* installing *source* package ‘volesti’ ...
** this is package ‘volesti’ version ‘1.1.2-9’
** package ‘volesti’ successfully unpacked and MD5 sums checked
** using staged installation
** libs
using C++ compiler: ‘g++ (GCC) 15.1.1 20250521 (Red Hat 15.1.1-2)’
make[1]: Entering directory '/data/gannet/ripley/R/packages/tests-devel/volesti/src'
g++ -std=gnu++17 -I"/data/gannet/ripley/R/R-devel/include" -DNDEBUG -Iexternal -Iexternal/lpsolve/headers/run_headers -Iexternal/minimum_ellipsoid -Iinclude -Iinclude/convex_bodies/spectrahedra -I'/data/gannet/ripley/R/test-dev/Rcpp/include' -I'/data/gannet/ripley/R/test-dev/RcppEigen/include' -I'/data/gannet/ripley/R/test-dev/BH/include' -I/usr/local/include -DBOOST_NO_AUTO_PTR -fpic -g -O2 -Wall -pedantic -mtune=native -Wno-ignored-attributes -Wno-parentheses -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -c RcppExports.cpp -o RcppExports.o
g++ -std=gnu++17 -I"/data/gannet/ripley/R/R-devel/include" -DNDEBUG -Iexternal -Iexternal/lpsolve/headers/run_headers -Iexternal/minimum_ellipsoid -Iinclude -Iinclude/convex_bodies/spectrahedra -I'/data/gannet/ripley/R/test-dev/Rcpp/include' -I'/data/gannet/ripley/R/test-dev/RcppEigen/include' -I'/data/gannet/ripley/R/test-dev/BH/include' -I/usr/local/include -DBOOST_NO_AUTO_PTR -fpic -g -O2 -Wall -pedantic -mtune=native -Wno-ignored-attributes -Wno-parentheses -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -c copula.cpp -o copula.o
g++ -std=gnu++17 -I"/data/gannet/ripley/R/R-devel/include" -DNDEBUG -Iexternal -Iexternal/lpsolve/headers/run_headers -Iexternal/minimum_ellipsoid -Iinclude -Iinclude/convex_bodies/spectrahedra -I'/data/gannet/ripley/R/test-dev/Rcpp/include' -I'/data/gannet/ripley/R/test-dev/RcppEigen/include' -I'/data/gannet/ripley/R/test-dev/BH/include' -I/usr/local/include -DBOOST_NO_AUTO_PTR -fpic -g -O2 -Wall -pedantic -mtune=native -Wno-ignored-attributes -Wno-parentheses -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -c direct_sampling.cpp -o direct_sampling.o
copula.cpp: In function ‘Rcpp::NumericMatrix copula(Rcpp::Nullable<Rcpp::Vector<14, Rcpp::PreserveStorage> >, Rcpp::Nullable<Rcpp::Vector<14, Rcpp::PreserveStorage> >, Rcpp::Nullable<Rcpp::Matrix<14> >, Rcpp::Nullable<unsigned int>, Rcpp::Nullable<unsigned int>, Rcpp::Nullable<double>)’:
copula.cpp:93:24: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
93 | for (int i=0; i<dim; i++) {
| ~^~~~
copula.cpp:94:31: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
94 | for (int j = 0; j < dim; j++) {
| ~~^~~~~
copula.cpp:106:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
106 | for(int i=0; i<num_slices; i++) {
| ~^~~~~~~~~~~
copula.cpp:107:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
107 | for(int j=0; j<num_slices; j++){
| ~^~~~~~~~~~~
copula.cpp:81:63: warning: unused variable ‘i’ [-Wunused-variable]
81 | unsigned int dim = Rcpp::as<std::vector<NT> >(r1).size(), i, j;
| ^
copula.cpp:81:66: warning: unused variable ‘j’ [-Wunused-variable]
81 | unsigned int dim = Rcpp::as<std::vector<NT> >(r1).size(), i, j;
| ^
direct_sampling.cpp: In function ‘Rcpp::NumericMatrix direct_sampling(Rcpp::List, int)’:
direct_sampling.cpp:89:36: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
89 | for (unsigned int k = 0; k < numpoints; ++k) {
| ~~^~~~~~~~~~~
direct_sampling.cpp:95:36: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
95 | for (unsigned int k = 0; k < numpoints; ++k) {
| ~~^~~~~~~~~~~
direct_sampling.cpp:52:50: warning: typedef ‘VT’ locally defined but not used [-Wunused-local-typedefs]
52 | typedef Eigen::Matrix<NT, Eigen::Dynamic, 1> VT;
| ^~
g++ -std=gnu++17 -I"/data/gannet/ripley/R/R-devel/include" -DNDEBUG -Iexternal -Iexternal/lpsolve/headers/run_headers -Iexternal/minimum_ellipsoid -Iinclude -Iinclude/convex_bodies/spectrahedra -I'/data/gannet/ripley/R/test-dev/Rcpp/include' -I'/data/gannet/ripley/R/test-dev/RcppEigen/include' -I'/data/gannet/ripley/R/test-dev/BH/include' -I/usr/local/include -DBOOST_NO_AUTO_PTR -fpic -g -O2 -Wall -pedantic -mtune=native -Wno-ignored-attributes -Wno-parentheses -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -c exact_vol.cpp -o exact_vol.o
g++ -std=gnu++17 -I"/data/gannet/ripley/R/R-devel/include" -DNDEBUG -Iexternal -Iexternal/lpsolve/headers/run_headers -Iexternal/minimum_ellipsoid -Iinclude -Iinclude/convex_bodies/spectrahedra -I'/data/gannet/ripley/R/test-dev/Rcpp/include' -I'/data/gannet/ripley/R/test-dev/RcppEigen/include' -I'/data/gannet/ripley/R/test-dev/BH/include' -I/usr/local/include -DBOOST_NO_AUTO_PTR -fpic -g -O2 -Wall -pedantic -mtune=native -Wno-ignored-attributes -Wno-parentheses -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -c frustum_of_simplex.cpp -o frustum_of_simplex.o
g++ -std=gnu++17 -I"/data/gannet/ripley/R/R-devel/include" -DNDEBUG -Iexternal -Iexternal/lpsolve/headers/run_headers -Iexternal/minimum_ellipsoid -Iinclude -Iinclude/convex_bodies/spectrahedra -I'/data/gannet/ripley/R/test-dev/Rcpp/include' -I'/data/gannet/ripley/R/test-dev/RcppEigen/include' -I'/data/gannet/ripley/R/test-dev/BH/include' -I/usr/local/include -DBOOST_NO_AUTO_PTR -fpic -g -O2 -Wall -pedantic -mtune=native -Wno-ignored-attributes -Wno-parentheses -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -c inner_ball.cpp -o inner_ball.o
In file included from include/volume/volume_sequence_of_balls.hpp:27,
from inner_ball.cpp:14:
include/convex_bodies/vpolytope.h: In instantiation of ‘std::pair<Point, typename Point::FT> VPolytope<Point>::ComputeInnerBall() [with Point = point<Cartesian<double> >; typename Point::FT = double]’:
inner_ball.cpp:80:44: required from here
80 | InnerBall = VP.ComputeInnerBall();
| ~~~~~~~~~~~~~~~~~~~^~
include/convex_bodies/vpolytope.h:278:30: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
278 | for ( i=0; i < rpit->dimension(); i++){
| ~~^~~~~~~~~~~~~~~~~~~
include/convex_bodies/vpolytope.h: In instantiation of ‘bool VPolytope<Point>::get_points_for_rounding(PointList&) [with PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; Point = point<Cartesian<double> >]’:
include/convex_bodies/vpolytope.h:267:37: required from ‘std::pair<Point, typename Point::FT> VPolytope<Point>::ComputeInnerBall() [with Point = point<Cartesian<double> >; typename Point::FT = double]’
267 | if (!get_points_for_rounding(randPoints)) {
| ~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~
inner_ball.cpp:80:44: required from here
80 | InnerBall = VP.ComputeInnerBall();
| ~~~~~~~~~~~~~~~~~~~^~
include/convex_bodies/vpolytope.h:408:30: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
408 | if (num_of_vertices()>20*_d) {
| ~~~~~~~~~~~~~~~~~^~~~~~
include/convex_bodies/vpolytope.h:411:22: warning: unused variable ‘j’ [-Wunused-variable]
411 | unsigned int j;
| ^
In file included from include/convex_bodies/vpolytope.h:18:
include/lp_oracles/vpolyoracles.h: In instantiation of ‘std::pair<_FIter, _FIter> intersect_double_line_Vpoly(const MT&, const Point&, const Point&, NT*, int*) [with NT = double; MT = Eigen::Matrix<double, -1, -1>; Point = point<Cartesian<double> >]’:
include/convex_bodies/vpolytope.h:297:50: required from ‘std::pair<Point, typename Point::FT> VPolytope<Point>::ComputeInnerBall() [with Point = point<Cartesian<double> >; typename Point::FT = double]’
297 | res = intersect_double_line_Vpoly<NT>(V, center, v, row, colno);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
inner_ball.cpp:80:44: required from here
80 | InnerBall = VP.ComputeInnerBall();
| ~~~~~~~~~~~~~~~~~~~^~
include/lp_oracles/vpolyoracles.h:311:8: warning: unused variable ‘res’ [-Wunused-variable]
311 | NT res;
| ^~~
In file included from include/convex_bodies/hpolytope.h:17,
from include/volume/volume_sequence_of_balls.hpp:26:
include/lp_oracles/solve_lp.h: In instantiation of ‘Point PointInIntersection(MT, MT, Point, bool&) [with VT = Eigen::Matrix<double, -1, 1>; MT = Eigen::Matrix<double, -1, -1>; Point = point<Cartesian<double> >]’:
include/convex_bodies/vpolyintersectvpoly.h:128:32: required from ‘bool IntersectionOfVpoly<VPolytope, RNGType>::is_feasible() [with VPolytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
128 | PointInIntersection<VT>(P1.get_mat(), P2.get_mat(),
| ~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
129 | GetDirection<Point>::apply(k, rng), empty);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
inner_ball.cpp:99:35: required from here
99 | if (!VPcVP.is_feasible()) throw Rcpp::exception("Empty set!");
| ~~~~~~~~~~~~~~~~~^~
include/lp_oracles/solve_lp.h:204:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
204 | for (i = 0; i< d+2; ++i) {
| ~^~~~~
include/lp_oracles/solve_lp.h:206:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
206 | for(j=0; j<k1; j++){
| ~^~~
include/lp_oracles/solve_lp.h:208:18: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
208 | if (i==d) {
| ~^~~
include/lp_oracles/solve_lp.h:210:24: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
210 | } else if(i==d+1){
| ~^~~~~
include/lp_oracles/solve_lp.h:216:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
216 | for(j=0; j<k2; j++){
| ~^~~
include/lp_oracles/solve_lp.h:218:18: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
218 | if (i==d) {
| ~^~~
include/lp_oracles/solve_lp.h:220:24: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
220 | } else if(i==d+1){
| ~^~~~~
include/lp_oracles/solve_lp.h:229:17: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
229 | if(i==d || i==d+1) {
| ~^~~
include/lp_oracles/solve_lp.h:229:25: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
229 | if(i==d || i==d+1) {
| ~^~~~~
include/lp_oracles/solve_lp.h:285:17: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
285 | for ( j=0; j<k1; ++j) {
| ~^~~
In file included from include/cartesian_geom/cartesian_kernel.h:25,
from inner_ball.cpp:9:
include/cartesian_geom/point.h: In instantiation of ‘bool point<K>::operator==(point<K>&) const [with K = Cartesian<double>]’:
include/convex_bodies/vpolyintersectvpoly.h:154:22: required from ‘std::pair<typename VPolytope::PointType, typename VPolytope::NT> IntersectionOfVpoly<VPolytope, RNGType>::ComputeInnerBall() [with VPolytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; typename VPolytope::PointType = point<Cartesian<double> >; typename VPolytope::NT = double]’
154 | if (p==(*rvert)) {
| ~^~~~~~~~~~
inner_ball.cpp:100:47: required from here
100 | InnerBall = VPcVP.ComputeInnerBall();
| ~~~~~~~~~~~~~~~~~~~~~~^~
include/cartesian_geom/point.h:157:21: warning: comparison of integer expressions of different signedness: ‘int’ and ‘const unsigned int’ [-Wsign-compare]
157 | for (i=0 ; i<d ; i++) {
| ~^~
In file included from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Core:337,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Dense:1,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/RcppEigenForward.h:28,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/RcppEigen.h:25,
from exact_vol.cpp:9:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h: In function ‘static void Eigen::internal::selfadjoint_product_impl<Lhs, LhsMode, false, Rhs, 0, true>::run(Dest&, const Lhs&, const Rhs&, const Scalar&) [with Dest = Eigen::Block<Eigen::Matrix<double, -1, 1>, -1, 1, false>; Lhs = Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>; int LhsMode = 17; Rhs = Eigen::CwiseBinaryOp<Eigen::internal::scalar_product_op<double, double>, const Eigen::CwiseNullaryOp<Eigen::internal::scalar_constant_op<double>, const Eigen::Matrix<double, -1, 1> >, const Eigen::Block<Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, 1, true>, -1, 1, false> >]’:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h:229:7: warning: ‘result’ may be used uninitialized [-Wmaybe-uninitialized]
227 | internal::selfadjoint_matrix_vector_product<Scalar, Index, (internal::traits<ActualLhsTypeCleaned>::Flags&RowMajorBit) ? RowMajor : ColMajor,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
228 | int(LhsUpLo), bool(LhsBlasTraits::NeedToConjugate), bool(RhsBlasTraits::NeedToConjugate)>::run
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
229 | (
| ^
230 | lhs.rows(), // size
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
231 | &lhs.coeffRef(0,0), lhs.outerStride(), // lhs info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
232 | actualRhsPtr, // rhs info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
233 | actualDestPtr, // result info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
234 | actualAlpha // scale factor
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
235 | );
| ~
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h:41:6: note: by argument 4 of type ‘const double*’ to ‘static void Eigen::internal::selfadjoint_matrix_vector_product<Scalar, Index, StorageOrder, UpLo, ConjugateLhs, ConjugateRhs, Version>::run(Index, const Scalar*, Index, const Scalar*, Scalar*, Scalar) [with Scalar = double; Index = long int; int StorageOrder = 0; int UpLo = 1; bool ConjugateLhs = false; bool ConjugateRhs = false; int Version = 0]’ declared here
41 | void selfadjoint_matrix_vector_product<Scalar,Index,StorageOrder,UpLo,ConjugateLhs,ConjugateRhs,Version>::run(
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
In file included from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Core:341:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h: In function ‘static void Eigen::internal::trmv_selector<Mode, 1>::run(const Lhs&, const Rhs&, Dest&, const typename Dest::Scalar&) [with Lhs = Eigen::Transpose<const Eigen::Block<const Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>, -1, -1, false> >; Rhs = Eigen::Transpose<const Eigen::CwiseBinaryOp<Eigen::internal::scalar_product_op<double, double>, const Eigen::CwiseNullaryOp<Eigen::internal::scalar_constant_op<double>, const Eigen::Matrix<double, 1, -1> >, const Eigen::Transpose<const Eigen::Block<const Eigen::Block<const Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>, -1, 1, true>, -1, 1, false> > > >; Dest = Eigen::Transpose<Eigen::Block<Eigen::Block<Eigen::Matrix<double, -1, -1, 1, -1, -1>, 1, -1, true>, 1, -1, false> >; int Mode = 6]’:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h:332:12: warning: ‘result’ may be used uninitialized [-Wmaybe-uninitialized]
327 | internal::triangular_matrix_vector_product
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
328 | <Index,Mode,
| ~~~~~~~~~~~~
329 | LhsScalar, LhsBlasTraits::NeedToConjugate,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
330 | RhsScalar, RhsBlasTraits::NeedToConjugate,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
331 | RowMajor>
| ~~~~~~~~~
332 | ::run(actualLhs.rows(),actualLhs.cols(),
| ~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
333 | actualLhs.data(),actualLhs.outerStride(),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
334 | actualRhsPtr,1,
| ~~~~~~~~~~~~~~~
335 | dest.data(),dest.innerStride(),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
336 | actualAlpha);
| ~~~~~~~~~~~~
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h:105:24: note: by argument 5 of type ‘const double*’ to ‘static void Eigen::internal::triangular_matrix_vector_product<Index, Mode, LhsScalar, ConjLhs, RhsScalar, ConjRhs, 1, Version>::run(Index, Index, const LhsScalar*, Index, const RhsScalar*, Index, ResScalar*, Index, const ResScalar&) [with Index = long int; int Mode = 6; LhsScalar = double; bool ConjLhs = false; RhsScalar = double; bool ConjRhs = false; int Version = 0]’ declared here
105 | EIGEN_DONT_INLINE void triangular_matrix_vector_product<Index,Mode,LhsScalar,ConjLhs,RhsScalar,ConjRhs,RowMajor,Version>
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
In file included from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Core:337,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Dense:1,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/RcppEigenForward.h:28,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/RcppEigen.h:25,
from inner_ball.cpp:7:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h: In function ‘static void Eigen::internal::selfadjoint_product_impl<Lhs, LhsMode, false, Rhs, 0, true>::run(Dest&, const Lhs&, const Rhs&, const Scalar&) [with Dest = Eigen::Block<Eigen::Matrix<double, -1, 1>, -1, 1, false>; Lhs = Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>; int LhsMode = 17; Rhs = Eigen::CwiseBinaryOp<Eigen::internal::scalar_product_op<double, double>, const Eigen::CwiseNullaryOp<Eigen::internal::scalar_constant_op<double>, const Eigen::Matrix<double, -1, 1> >, const Eigen::Block<Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, 1, true>, -1, 1, false> >]’:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h:229:7: warning: ‘result’ may be used uninitialized [-Wmaybe-uninitialized]
227 | internal::selfadjoint_matrix_vector_product<Scalar, Index, (internal::traits<ActualLhsTypeCleaned>::Flags&RowMajorBit) ? RowMajor : ColMajor,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
228 | int(LhsUpLo), bool(LhsBlasTraits::NeedToConjugate), bool(RhsBlasTraits::NeedToConjugate)>::run
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
229 | (
| ^
230 | lhs.rows(), // size
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
231 | &lhs.coeffRef(0,0), lhs.outerStride(), // lhs info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
232 | actualRhsPtr, // rhs info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
233 | actualDestPtr, // result info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
234 | actualAlpha // scale factor
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
235 | );
| ~
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h:41:6: note: by argument 4 of type ‘const double*’ to ‘static void Eigen::internal::selfadjoint_matrix_vector_product<Scalar, Index, StorageOrder, UpLo, ConjugateLhs, ConjugateRhs, Version>::run(Index, const Scalar*, Index, const Scalar*, Scalar*, Scalar) [with Scalar = double; Index = long int; int StorageOrder = 0; int UpLo = 1; bool ConjugateLhs = false; bool ConjugateRhs = false; int Version = 0]’ declared here
41 | void selfadjoint_matrix_vector_product<Scalar,Index,StorageOrder,UpLo,ConjugateLhs,ConjugateRhs,Version>::run(
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
g++ -std=gnu++17 -I"/data/gannet/ripley/R/R-devel/include" -DNDEBUG -Iexternal -Iexternal/lpsolve/headers/run_headers -Iexternal/minimum_ellipsoid -Iinclude -Iinclude/convex_bodies/spectrahedra -I'/data/gannet/ripley/R/test-dev/Rcpp/include' -I'/data/gannet/ripley/R/test-dev/RcppEigen/include' -I'/data/gannet/ripley/R/test-dev/BH/include' -I/usr/local/include -DBOOST_NO_AUTO_PTR -fpic -g -O2 -Wall -pedantic -mtune=native -Wno-ignored-attributes -Wno-parentheses -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -c load_sdpa_format_file.cpp -o load_sdpa_format_file.o
In file included from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Core:341:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h: In function ‘static void Eigen::internal::trmv_selector<Mode, 1>::run(const Lhs&, const Rhs&, Dest&, const typename Dest::Scalar&) [with Lhs = Eigen::Transpose<const Eigen::Block<const Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>, -1, -1, false> >; Rhs = Eigen::Transpose<const Eigen::CwiseBinaryOp<Eigen::internal::scalar_product_op<double, double>, const Eigen::CwiseNullaryOp<Eigen::internal::scalar_constant_op<double>, const Eigen::Matrix<double, 1, -1> >, const Eigen::Transpose<const Eigen::Block<const Eigen::Block<const Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>, -1, 1, true>, -1, 1, false> > > >; Dest = Eigen::Transpose<Eigen::Block<Eigen::Block<Eigen::Matrix<double, -1, -1, 1, -1, -1>, 1, -1, true>, 1, -1, false> >; int Mode = 6]’:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h:332:12: warning: ‘result’ may be used uninitialized [-Wmaybe-uninitialized]
327 | internal::triangular_matrix_vector_product
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
328 | <Index,Mode,
| ~~~~~~~~~~~~
329 | LhsScalar, LhsBlasTraits::NeedToConjugate,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
330 | RhsScalar, RhsBlasTraits::NeedToConjugate,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
331 | RowMajor>
| ~~~~~~~~~
332 | ::run(actualLhs.rows(),actualLhs.cols(),
| ~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
333 | actualLhs.data(),actualLhs.outerStride(),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
334 | actualRhsPtr,1,
| ~~~~~~~~~~~~~~~
335 | dest.data(),dest.innerStride(),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
336 | actualAlpha);
| ~~~~~~~~~~~~
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h:105:24: note: by argument 5 of type ‘const double*’ to ‘static void Eigen::internal::triangular_matrix_vector_product<Index, Mode, LhsScalar, ConjLhs, RhsScalar, ConjRhs, 1, Version>::run(Index, Index, const LhsScalar*, Index, const RhsScalar*, Index, ResScalar*, Index, const ResScalar&) [with Index = long int; int Mode = 6; LhsScalar = double; bool ConjLhs = false; RhsScalar = double; bool ConjRhs = false; int Version = 0]’ declared here
105 | EIGEN_DONT_INLINE void triangular_matrix_vector_product<Index,Mode,LhsScalar,ConjLhs,RhsScalar,ConjRhs,RowMajor,Version>
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
load_sdpa_format_file.cpp: In function ‘Rcpp::List load_sdpa_format_file(Rcpp::Nullable<std::__cxx11::basic_string<char> >)’:
load_sdpa_format_file.cpp:37:28: warning: typedef ‘RNGType’ locally defined but not used [-Wunused-local-typedefs]
37 | typedef boost::mt19937 RNGType;
| ^~~~~~~
load_sdpa_format_file.cpp:38:29: warning: typedef ‘LMI’ locally defined but not used [-Wunused-local-typedefs]
38 | typedef LMI<NT, MT, VT> LMI;
| ^~~
In file included from load_sdpa_format_file.cpp:20:
include/SDPAFormatManager.h: In instantiation of ‘void SdpaFormatManager<NT>::loadSDPAFormatFile(std::ifstream&, std::vector<Eigen::Matrix<Type, -1, -1> >&, VT&) [with NT = double; std::ifstream = std::basic_ifstream<char>; VT = Eigen::Matrix<double, -1, 1>]’:
include/SDPAFormatManager.h:250:27: required from ‘void SdpaFormatManager<NT>::loadSDPAFormatFile(std::ifstream&, Spectrahedron<NT, Eigen::Matrix<Type, -1, -1>, Eigen::Matrix<Type, -1, 1> >&, Point&) [with Point = point<Cartesian<double> >; NT = double; std::ifstream = std::basic_ifstream<char>]’
250 | loadSDPAFormatFile(is, matrices, coeffs);
| ~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
load_sdpa_format_file.cpp:50:41: required from here
50 | sdpaFormatManager.loadSDPAFormatFile(os, _spectrahedron, c);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~
include/SDPAFormatManager.h:130:35: warning: comparison of integer expressions of different signedness: ‘std::__cxx11::list<double, std::allocator<double> >::size_type’ {aka ‘long unsigned int’} and ‘int’ [-Wsign-compare]
130 | if (blockStructure.size() != blocksNum)
| ~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~
include/SDPAFormatManager.h:139:38: warning: comparison of integer expressions of different signedness: ‘std::__cxx11::list<double, std::allocator<double> >::size_type’ {aka ‘long unsigned int’} and ‘int’ [-Wsign-compare]
139 | while (constantVector.size() < variablesNum) {
| ~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~
include/SDPAFormatManager.h:153:41: warning: comparison of integer expressions of different signedness: ‘int’ and ‘std::vector<Eigen::Matrix<double, -1, -1>, std::allocator<Eigen::Matrix<double, -1, -1> > >::size_type’ {aka ‘long unsigned int’} [-Wsign-compare]
153 | for (int atMatrix = 0; atMatrix < matrices.size(); atMatrix++) {
| ~~~~~~~~~^~~~~~~~~~~~~~~~~
include/SDPAFormatManager.h:106:32: warning: unused variable ‘sz’ [-Wunused-variable]
106 | std::string::size_type sz;
| ^~
In file included from load_sdpa_format_file.cpp:18:
include/convex_bodies/spectrahedra/LMI.h: In instantiation of ‘void LMI<NT, Eigen::Matrix<Type, -1, -1>, Eigen::Matrix<Type, -1, 1> >::setVectorMatrix() [with NT = double]’:
include/convex_bodies/spectrahedra/LMI.h:61:9: required from ‘LMI<NT, Eigen::Matrix<Type, -1, -1>, Eigen::Matrix<Type, -1, 1> >::LMI(const std::vector<Eigen::Matrix<Type, -1, -1> >&) [with NT = double]’
61 | setVectorMatrix();
| ^~~~~~~~~~~~~~~
include/SDPAFormatManager.h:251:25: required from ‘void SdpaFormatManager<NT>::loadSDPAFormatFile(std::ifstream&, Spectrahedron<NT, Eigen::Matrix<Type, -1, -1>, Eigen::Matrix<Type, -1, 1> >&, Point&) [with Point = point<Cartesian<double> >; NT = double; std::ifstream = std::basic_ifstream<char>]’
251 | LMI<NT, MT, VT> lmi(matrices);
| ^~~
load_sdpa_format_file.cpp:50:41: required from here
50 | sdpaFormatManager.loadSDPAFormatFile(os, _spectrahedron, c);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/spectrahedra/LMI.h:82:41: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
82 | for (int at_row = 0; at_row < m; at_row++)
| ~~~~~~~^~~
include/convex_bodies/spectrahedra/LMI.h:83:50: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
83 | for (int at_col = at_row; at_col < m; at_col++) {
| ~~~~~~~^~~
g++ -std=gnu++17 -I"/data/gannet/ripley/R/R-devel/include" -DNDEBUG -Iexternal -Iexternal/lpsolve/headers/run_headers -Iexternal/minimum_ellipsoid -Iinclude -Iinclude/convex_bodies/spectrahedra -I'/data/gannet/ripley/R/test-dev/Rcpp/include' -I'/data/gannet/ripley/R/test-dev/RcppEigen/include' -I'/data/gannet/ripley/R/test-dev/BH/include' -I/usr/local/include -DBOOST_NO_AUTO_PTR -fpic -g -O2 -Wall -pedantic -mtune=native -Wno-ignored-attributes -Wno-parentheses -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -c poly_gen.cpp -o poly_gen.o
g++ -std=gnu++17 -I"/data/gannet/ripley/R/R-devel/include" -DNDEBUG -Iexternal -Iexternal/lpsolve/headers/run_headers -Iexternal/minimum_ellipsoid -Iinclude -Iinclude/convex_bodies/spectrahedra -I'/data/gannet/ripley/R/test-dev/Rcpp/include' -I'/data/gannet/ripley/R/test-dev/RcppEigen/include' -I'/data/gannet/ripley/R/test-dev/BH/include' -I/usr/local/include -DBOOST_NO_AUTO_PTR -fpic -g -O2 -Wall -pedantic -mtune=native -Wno-ignored-attributes -Wno-parentheses -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -c rotating.cpp -o rotating.o
In file included from poly_gen.cpp:23:
include/generators/v_polytopes_generators.h: In function ‘Polytope random_vpoly(unsigned int, unsigned int, double)’:
include/generators/v_polytopes_generators.h:32:23: warning: typedef ‘Point’ locally defined but not used [-Wunused-local-typedefs]
32 | typedef PointType Point;
| ^~~~~
In file included from poly_gen.cpp:24:
include/generators/z_polytopes_generators.h: In function ‘Polytope gen_zonotope_uniform(int, int, double)’:
include/generators/z_polytopes_generators.h:61:38: warning: typedef ‘NT’ locally defined but not used [-Wunused-local-typedefs]
61 | typedef typename Polytope::NT NT;
| ^~
include/generators/z_polytopes_generators.h: In instantiation of ‘Polytope gen_zonotope_uniform(int, int, double) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>]’:
poly_gen.cpp:57:78: required from here
57 | return extractMatPoly(gen_zonotope_uniform<zonotope, RNGType>(dim_gen, m_gen, seed2));
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~
include/generators/z_polytopes_generators.h:78:32: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
78 | for (unsigned int i = 0; i < m; ++i) {
| ~~^~~
include/generators/z_polytopes_generators.h:80:36: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
80 | for (unsigned int j = 0; j < dim; ++j) {
| ~~^~~~~
include/generators/z_polytopes_generators.h: In instantiation of ‘Polytope gen_zonotope_gaussian(int, int, double) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>]’:
poly_gen.cpp:59:79: required from here
59 | return extractMatPoly(gen_zonotope_gaussian<zonotope, RNGType>(dim_gen, m_gen, seed2));
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~
include/generators/z_polytopes_generators.h:36:32: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
36 | for (unsigned int i = 0; i < m; ++i) {
| ~~^~~
include/generators/z_polytopes_generators.h:38:36: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
38 | for (unsigned int j = 0; j < dim; ++j) {
| ~~^~~~~
include/generators/z_polytopes_generators.h: In instantiation of ‘Polytope gen_zonotope_exponential(int, int, double) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>]’:
poly_gen.cpp:61:82: required from here
61 | return extractMatPoly(gen_zonotope_exponential<zonotope, RNGType>(dim_gen, m_gen, seed2));
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~
include/generators/z_polytopes_generators.h:115:32: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
115 | for (unsigned int i = 0; i < m; ++i) {
| ~~^~~
include/generators/z_polytopes_generators.h:117:36: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
117 | for (unsigned int j = 0; j < dim; ++j) {
| ~~^~~~~
include/generators/v_polytopes_generators.h: In instantiation of ‘Polytope random_vpoly(unsigned int, unsigned int, double) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>]’:
poly_gen.cpp:78:71: required from here
78 | return extractMatPoly(random_vpoly<Vpolytope, RNGType>(dim_gen, m_gen, seed2));
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~
include/generators/v_polytopes_generators.h:44:18: warning: unused variable ‘j’ [-Wunused-variable]
44 | unsigned int j;
| ^
include/generators/v_polytopes_generators.h: In instantiation of ‘Polytope random_vpoly_incube(unsigned int, unsigned int, double) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>]’:
poly_gen.cpp:81:78: required from here
81 | return extractMatPoly(random_vpoly_incube<Vpolytope, RNGType>(dim_gen, m_gen, seed2));
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~
include/generators/v_polytopes_generators.h:109:27: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
109 | for (int j = 0; j < d; ++j) {
| ~~^~~
include/generators/v_polytopes_generators.h:124:27: warning: comparison of integer expressions of different signedness: ‘int’ and ‘std::vector<int>::size_type’ {aka ‘long unsigned int’} [-Wsign-compare]
124 | for (int i = 0; i < indices.size(); ++i) {
| ~~^~~~~~~~~~~~~~~~
include/generators/v_polytopes_generators.h:126:31: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
126 | for (int j = 0; j < d; ++j) {
| ~~^~~
include/generators/v_polytopes_generators.h:134:27: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
134 | for (int i = 0; i < k; ++i) {
| ~~^~~
include/generators/v_polytopes_generators.h:135:31: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
135 | for (int j = 0; j < d; ++j) {
| ~~^~~
include/generators/v_polytopes_generators.h:151:27: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
151 | for (int i = 0; i < k; ++i) {
| ~~^~~
include/generators/v_polytopes_generators.h:155:35: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
155 | for (int j = 0; j < d; ++j) V2(count_row, j) = V(i,j);
| ~~^~~
include/generators/v_polytopes_generators.h:103:18: warning: unused variable ‘j’ [-Wunused-variable]
103 | unsigned int j, count_row,it=0;
| ^
In file included from poly_gen.cpp:22:
include/generators/h_polytopes_generator.h: In instantiation of ‘Polytope random_hpoly(unsigned int, unsigned int, double) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>]’:
poly_gen.cpp:103:71: required from here
103 | return extractMatPoly(random_hpoly<Hpolytope, RNGType>(dim_gen, m_gen, seed2));
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~
include/generators/h_polytopes_generator.h:34:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
34 | for (int i = 0; i < m; ++i) {
| ~~^~~
include/generators/h_polytopes_generator.h: In instantiation of ‘Polytope random_hpoly_ball(unsigned int, unsigned int, double) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>]’:
poly_gen.cpp:106:76: required from here
106 | return extractMatPoly(random_hpoly_ball<Hpolytope, RNGType>(dim_gen, m_gen, seed2));
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~
include/generators/h_polytopes_generator.h:82:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
82 | for (int i = 0; i < m; ++i) {
| ~~^~~
rotating.cpp: In function ‘Rcpp::NumericMatrix rotating(Rcpp::Reference, Rcpp::Nullable<Rcpp::Matrix<14> >, Rcpp::Nullable<int>)’:
rotating.cpp:42:53: warning: typedef ‘InterVP’ locally defined but not used [-Wunused-local-typedefs]
42 | typedef IntersectionOfVpoly<Vpolytope, RNGType> InterVP;
| ^~~~~~~
In file included from rotating.cpp:19:
include/volume/rotating.hpp: In instantiation of ‘MT rotating(Polytope&, unsigned int) [with MT = Eigen::Matrix<double, -1, -1>; Polytope = HPolytope<point<Cartesian<double> > >]’:
rotating.cpp:80:47: required from here
80 | TransorfMat = rotating < MT > (HP, seed2);
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~
include/volume/rotating.hpp:50:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
50 | for (int i = 0; i < n; ++i) {
| ~~^~~
include/volume/rotating.hpp:51:27: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
51 | for (int j = 0; j < n; ++j) {
| ~~^~~
include/volume/rotating.hpp: In instantiation of ‘MT rotating(Polytope&, unsigned int) [with MT = Eigen::Matrix<double, -1, -1>; Polytope = VPolytope<point<Cartesian<double> > >]’:
rotating.cpp:93:47: required from here
93 | TransorfMat = rotating < MT > (VP, seed2);
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~
include/volume/rotating.hpp:50:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
50 | for (int i = 0; i < n; ++i) {
| ~~^~~
include/volume/rotating.hpp:51:27: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
51 | for (int j = 0; j < n; ++j) {
| ~~^~~
include/volume/rotating.hpp: In instantiation of ‘MT rotating(Polytope&, unsigned int) [with MT = Eigen::Matrix<double, -1, -1>; Polytope = Zonotope<point<Cartesian<double> > >]’:
rotating.cpp:106:47: required from here
106 | TransorfMat = rotating < MT > (ZP, seed2);
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~
include/volume/rotating.hpp:50:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
50 | for (int i = 0; i < n; ++i) {
| ~~^~~
include/volume/rotating.hpp:51:27: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
51 | for (int j = 0; j < n; ++j) {
| ~~^~~
g++ -std=gnu++17 -I"/data/gannet/ripley/R/R-devel/include" -DNDEBUG -Iexternal -Iexternal/lpsolve/headers/run_headers -Iexternal/minimum_ellipsoid -Iinclude -Iinclude/convex_bodies/spectrahedra -I'/data/gannet/ripley/R/test-dev/Rcpp/include' -I'/data/gannet/ripley/R/test-dev/RcppEigen/include' -I'/data/gannet/ripley/R/test-dev/BH/include' -I/usr/local/include -DBOOST_NO_AUTO_PTR -fpic -g -O2 -Wall -pedantic -mtune=native -Wno-ignored-attributes -Wno-parentheses -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -c rounding.cpp -o rounding.o
In file included from rounding.cpp:20:
include/volume/volume_cooling_gaussians.hpp: In function ‘NT get_next_gaussian(const Polytope&, Point&, const NT&, const unsigned int&, const NT&, const NT&, const unsigned int&, RandomNumberGenerator&)’:
include/volume/volume_cooling_gaussians.hpp:166:48: warning: typedef ‘viterator’ locally defined but not used [-Wunused-local-typedefs]
166 | typedef typename std::vector<NT>::iterator viterator;
| ^~~~~~~~~
include/volume/volume_cooling_gaussians.hpp: In function ‘void compute_annealing_schedule(const Polytope&, const NT&, const NT&, const NT&, const unsigned int&, const unsigned int&, const NT&, const NT&, std::vector<NT>&, RandomNumberGenerator&)’:
include/volume/volume_cooling_gaussians.hpp:221:35: warning: typedef ‘VT’ locally defined but not used [-Wunused-local-typedefs]
221 | typedef typename Polytope::VT VT;
| ^~
In file included from include/random_walks/uniform_billiard_walk.hpp:18,
from include/random_walks/random_walks.hpp:16,
from rounding.cpp:18:
include/convex_bodies/vpolytope.h: In instantiation of ‘std::pair<Point, typename Point::FT> VPolytope<Point>::ComputeInnerBall() [with Point = point<Cartesian<double> >; typename Point::FT = double]’:
rounding.cpp:117:44: required from here
117 | InnerBall = VP.ComputeInnerBall();
| ~~~~~~~~~~~~~~~~~~~^~
include/convex_bodies/vpolytope.h:278:30: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
278 | for ( i=0; i < rpit->dimension(); i++){
| ~~^~~~~~~~~~~~~~~~~~~
In file included from include/volume/volume_sequence_of_balls.hpp:33,
from rounding.cpp:19:
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = CDHRWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
rounding.cpp:135:61: required from here
135 | round_res = round_polytope<CDHRWalk, MT, VT>(HP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = RDHRWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
rounding.cpp:137:61: required from here
137 | round_res = round_polytope<RDHRWalk, MT, VT>(HP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
rounding.cpp:139:65: required from here
139 | round_res = round_polytope<BilliardWalk, MT, VT>(HP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = CDHRWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = VPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
rounding.cpp:146:61: required from here
146 | round_res = round_polytope<CDHRWalk, MT, VT>(VP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = RDHRWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = VPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
rounding.cpp:148:61: required from here
148 | round_res = round_polytope<RDHRWalk, MT, VT>(VP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = VPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
rounding.cpp:150:65: required from here
150 | round_res = round_polytope<BilliardWalk, MT, VT>(VP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = CDHRWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
rounding.cpp:157:61: required from here
157 | round_res = round_polytope<CDHRWalk, MT, VT>(ZP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = RDHRWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
rounding.cpp:159:61: required from here
159 | round_res = round_polytope<RDHRWalk, MT, VT>(ZP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
rounding.cpp:161:65: required from here
161 | round_res = round_polytope<BilliardWalk, MT, VT>(ZP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
include/convex_bodies/vpolytope.h: In instantiation of ‘bool VPolytope<Point>::get_points_for_rounding(PointList&) [with PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; Point = point<Cartesian<double> >]’:
include/convex_bodies/vpolytope.h:267:37: required from ‘std::pair<Point, typename Point::FT> VPolytope<Point>::ComputeInnerBall() [with Point = point<Cartesian<double> >; typename Point::FT = double]’
267 | if (!get_points_for_rounding(randPoints)) {
| ~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~
rounding.cpp:117:44: required from here
117 | InnerBall = VP.ComputeInnerBall();
| ~~~~~~~~~~~~~~~~~~~^~
include/convex_bodies/vpolytope.h:408:30: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
408 | if (num_of_vertices()>20*_d) {
| ~~~~~~~~~~~~~~~~~^~~~~~
include/convex_bodies/vpolytope.h:411:22: warning: unused variable ‘j’ [-Wunused-variable]
411 | unsigned int j;
| ^
In file included from include/convex_bodies/vpolytope.h:18:
include/lp_oracles/vpolyoracles.h: In instantiation of ‘std::pair<_FIter, _FIter> intersect_double_line_Vpoly(const MT&, const Point&, const Point&, NT*, int*) [with NT = double; MT = Eigen::Matrix<double, -1, -1>; Point = point<Cartesian<double> >]’:
include/convex_bodies/vpolytope.h:297:50: required from ‘std::pair<Point, typename Point::FT> VPolytope<Point>::ComputeInnerBall() [with Point = point<Cartesian<double> >; typename Point::FT = double]’
297 | res = intersect_double_line_Vpoly<NT>(V, center, v, row, colno);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
rounding.cpp:117:44: required from here
117 | InnerBall = VP.ComputeInnerBall();
| ~~~~~~~~~~~~~~~~~~~^~
include/lp_oracles/vpolyoracles.h:311:8: warning: unused variable ‘res’ [-Wunused-variable]
311 | NT res;
| ^~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = HPolytope<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/sampling/random_point_generators.hpp:63:23: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = BilliardWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
63 | walk.apply(P, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:60:40: required from ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
60 | RandomPointGenerator::apply(P, p, num_of_samples, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
61 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
rounding.cpp:139:65: required from here
139 | round_res = round_polytope<BilliardWalk, MT, VT>(HP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = VPolytope<point<Cartesian<double> > >; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/sampling/random_point_generators.hpp:63:23: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = VPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = BilliardWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
63 | walk.apply(P, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:60:40: required from ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = VPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
60 | RandomPointGenerator::apply(P, p, num_of_samples, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
61 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
rounding.cpp:150:65: required from here
150 | round_res = round_polytope<BilliardWalk, MT, VT>(VP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/sampling/random_point_generators.hpp:63:23: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
63 | walk.apply(P, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:60:40: required from ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
60 | RandomPointGenerator::apply(P, p, num_of_samples, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
61 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
rounding.cpp:161:65: required from here
161 | round_res = round_polytope<BilliardWalk, MT, VT>(ZP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
In file included from include/random_walks/uniform_billiard_walk.hpp:17:
include/convex_bodies/hpolytope.h: In instantiation of ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&, VT&, VT&, const NT&, bool) const [with Point = point<Cartesian<double> >; typename Point::FT = double; VT = Eigen::Matrix<double, -1, 1>; NT = double]’:
include/random_walks/uniform_rdhr_walk.hpp:64:55: required from ‘void RDHRWalk::Walk<Polytope, RandomNumberGenerator>::apply(const BallPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with BallPolytope = HPolytope<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
64 | std::pair<NT, NT> bpair = P.line_intersect(_p, v, _lamdas, _Av,
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
65 | _lambda);
| ~~~~~~~~
include/sampling/random_point_generators.hpp:63:23: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = RDHRWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
63 | walk.apply(P, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:60:40: required from ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = RDHRWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
60 | RandomPointGenerator::apply(P, p, num_of_samples, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
61 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
rounding.cpp:137:61: required from here
137 | round_res = round_polytope<RDHRWalk, MT, VT>(HP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/hpolytope.h:313:12: warning: unused variable ‘mult’ [-Wunused-variable]
313 | NT mult;
| ^~~~
include/convex_bodies/hpolytope.h:315:22: warning: unused variable ‘j’ [-Wunused-variable]
315 | unsigned int j;
| ^
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = HPolytope<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:221:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = HPolytope<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
221 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/sampling/random_point_generators.hpp:60:14: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = BilliardWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
60 | Walk walk(P, p, rng);
| ^~~~
include/volume/rounding.hpp:60:40: required from ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
60 | RandomPointGenerator::apply(P, p, num_of_samples, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
61 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
rounding.cpp:139:65: required from here
139 | round_res = round_polytope<BilliardWalk, MT, VT>(HP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = VPolytope<point<Cartesian<double> > >; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:221:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = VPolytope<point<Cartesian<double> > >; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
221 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/sampling/random_point_generators.hpp:60:14: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = VPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = BilliardWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
60 | Walk walk(P, p, rng);
| ^~~~
include/volume/rounding.hpp:60:40: required from ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = VPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
60 | RandomPointGenerator::apply(P, p, num_of_samples, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
61 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
rounding.cpp:150:65: required from here
150 | round_res = round_polytope<BilliardWalk, MT, VT>(VP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘static NT compute_diameter<Zonotope<Point> >::compute(const Zonotope<Point>&) [with NT = double; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:220:39: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
219 | _Len = compute_diameter<GenericPolytope>
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
220 | ::template compute<NT>(P);
| ~~~~~~~~~~~~~~~~~~~~~~^~~
include/sampling/random_point_generators.hpp:60:14: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
60 | Walk walk(P, p, rng);
| ^~~~
include/volume/rounding.hpp:60:40: required from ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
60 | RandomPointGenerator::apply(P, p, num_of_samples, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
61 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
rounding.cpp:161:65: required from here
161 | round_res = round_polytope<BilliardWalk, MT, VT>(ZP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:84:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
84 | for (int i = 0; i < P.dimension(); ++i) {
| ~~^~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:221:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
221 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/sampling/random_point_generators.hpp:60:14: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
60 | Walk walk(P, p, rng);
| ^~~~
include/volume/rounding.hpp:60:40: required from ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
60 | RandomPointGenerator::apply(P, p, num_of_samples, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
61 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
rounding.cpp:161:65: required from here
161 | round_res = round_polytope<BilliardWalk, MT, VT>(ZP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
In file included from include/convex_bodies/zpolytope.h:19,
from include/random_walks/uniform_billiard_walk.hpp:20:
include/lp_oracles/zpolyoracles.h: In instantiation of ‘std::pair<_FIter, _FIter> intersect_line_zono(const MT&, const Point&, const Point&, NT*, int*) [with NT = double; MT = Eigen::Matrix<double, -1, -1>; Point = point<Cartesian<double> >]’:
include/convex_bodies/zpolytope.h:296:35: required from ‘std::pair<typename Point::FT, typename Point::FT> Zonotope<Point>::line_intersect(const Point&, const Point&, const VT&, const VT&, const NT&) const [with Point = point<Cartesian<double> >; typename Point::FT = double; VT = Eigen::Matrix<double, -1, 1>; NT = double]’
296 | return intersect_line_zono(V, r, v, conv_comb, colno);
| ~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_rdhr_walk.hpp:64:55: required from ‘void RDHRWalk::Walk<Polytope, RandomNumberGenerator>::apply(const BallPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with BallPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
64 | std::pair<NT, NT> bpair = P.line_intersect(_p, v, _lamdas, _Av,
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
65 | _lambda);
| ~~~~~~~~
include/sampling/random_point_generators.hpp:63:23: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = RDHRWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
63 | walk.apply(P, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:60:40: required from ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = RDHRWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
60 | RandomPointGenerator::apply(P, p, num_of_samples, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
61 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
rounding.cpp:159:61: required from here
159 | round_res = round_polytope<RDHRWalk, MT, VT>(ZP, InnerBall, walkL, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/lp_oracles/zpolyoracles.h:140:8: warning: unused variable ‘res’ [-Wunused-variable]
140 | NT res;
| ^~~
In file included from include/cartesian_geom/cartesian_kernel.h:25,
from poly_gen.cpp:13:
In constructor ‘point<Cartesian<double> >::point(point<Cartesian<double> >&&)’,
inlined from ‘std::pair<_T1, _T2>::pair(std::pair<_T1, _T2>&&) [with _T1 = point<Cartesian<double> >; _T2 = double]’ at /usr/include/c++/15/bits/stl_pair.h:313:17,
inlined from ‘HPolytope<point<Cartesian<double> > >::HPolytope(HPolytope<point<Cartesian<double> > >&&)’ at include/convex_bodies/hpolytope.h:21:7,
inlined from ‘Polytope gen_prod_simplex(const unsigned int&, bool) [with Polytope = HPolytope<point<Cartesian<double> > >]’ at include/generators/known_polytope_generators.h:247:12:
include/cartesian_geom/point.h:17:7: warning: ‘*(point<Cartesian<double> >*)((char*)&P + offsetof(HPolytope<point<Cartesian<double> > >,HPolytope<point<Cartesian<double> > >::_inner_ball.std::pair<point<Cartesian<double> >, double>::<unnamed>)).point<Cartesian<double> >::d’ may be used uninitialized [-Wmaybe-uninitialized]
17 | class point
| ^~~~~
In file included from poly_gen.cpp:21:
include/generators/known_polytope_generators.h: In function ‘Polytope gen_prod_simplex(const unsigned int&, bool) [with Polytope = HPolytope<point<Cartesian<double> > >]’:
include/generators/known_polytope_generators.h:199:14: note: ‘P’ declared here
199 | Polytope P;
| ^
In file included from poly_gen.cpp:18:
In constructor ‘HPolytope<point<Cartesian<double> > >::HPolytope(HPolytope<point<Cartesian<double> > >&&)’,
inlined from ‘Polytope gen_prod_simplex(const unsigned int&, bool) [with Polytope = HPolytope<point<Cartesian<double> > >]’ at include/generators/known_polytope_generators.h:189:16:
include/convex_bodies/hpolytope.h:21:7: warning: ‘Perr.HPolytope<point<Cartesian<double> > >::_d’ may be used uninitialized [-Wmaybe-uninitialized]
21 | class HPolytope{
| ^~~~~~~~~
include/generators/known_polytope_generators.h: In function ‘Polytope gen_prod_simplex(const unsigned int&, bool) [with Polytope = HPolytope<point<Cartesian<double> > >]’:
include/generators/known_polytope_generators.h:180:14: note: ‘Perr’ declared here
180 | Polytope Perr;
| ^~~~
In constructor ‘point<Cartesian<double> >::point(point<Cartesian<double> >&&)’,
inlined from ‘std::pair<_T1, _T2>::pair(std::pair<_T1, _T2>&&) [with _T1 = point<Cartesian<double> >; _T2 = double]’ at /usr/include/c++/15/bits/stl_pair.h:313:17,
inlined from ‘HPolytope<point<Cartesian<double> > >::HPolytope(HPolytope<point<Cartesian<double> > >&&)’ at include/convex_bodies/hpolytope.h:21:7,
inlined from ‘Polytope gen_prod_simplex(const unsigned int&, bool) [with Polytope = HPolytope<point<Cartesian<double> > >]’ at include/generators/known_polytope_generators.h:189:16:
include/cartesian_geom/point.h:17:7: warning: ‘*(point<Cartesian<double> >*)((char*)&Perr + offsetof(HPolytope<point<Cartesian<double> > >,HPolytope<point<Cartesian<double> > >::_inner_ball.std::pair<point<Cartesian<double> >, double>::<unnamed>)).point<Cartesian<double> >::d’ may be used uninitialized [-Wmaybe-uninitialized]
17 | class point
| ^~~~~
include/generators/known_polytope_generators.h: In function ‘Polytope gen_prod_simplex(const unsigned int&, bool) [with Polytope = HPolytope<point<Cartesian<double> > >]’:
include/generators/known_polytope_generators.h:180:14: note: ‘Perr’ declared here
180 | Polytope Perr;
| ^~~~
In constructor ‘point<Cartesian<double> >::point(point<Cartesian<double> >&&)’,
inlined from ‘std::pair<_T1, _T2>::pair(std::pair<_T1, _T2>&&) [with _T1 = point<Cartesian<double> >; _T2 = double]’ at /usr/include/c++/15/bits/stl_pair.h:313:17,
inlined from ‘HPolytope<point<Cartesian<double> > >::HPolytope(HPolytope<point<Cartesian<double> > >&&)’ at include/convex_bodies/hpolytope.h:21:7,
inlined from ‘Polytope gen_skinny_cube(const unsigned int&, bool) [with Polytope = HPolytope<point<Cartesian<double> > >]’ at include/generators/known_polytope_generators.h:305:12:
include/cartesian_geom/point.h:17:7: warning: ‘*(point<Cartesian<double> >*)((char*)&P + offsetof(HPolytope<point<Cartesian<double> > >,HPolytope<point<Cartesian<double> > >::_inner_ball.std::pair<point<Cartesian<double> >, double>::<unnamed>)).point<Cartesian<double> >::d’ may be used uninitialized [-Wmaybe-uninitialized]
17 | class point
| ^~~~~
include/generators/known_polytope_generators.h: In function ‘Polytope gen_skinny_cube(const unsigned int&, bool) [with Polytope = HPolytope<point<Cartesian<double> > >]’:
include/generators/known_polytope_generators.h:302:14: note: ‘P’ declared here
302 | Polytope P;
| ^
In constructor ‘HPolytope<point<Cartesian<double> > >::HPolytope(HPolytope<point<Cartesian<double> > >&&)’,
inlined from ‘Polytope gen_skinny_cube(const unsigned int&, bool) [with Polytope = HPolytope<point<Cartesian<double> > >]’ at include/generators/known_polytope_generators.h:263:16:
include/convex_bodies/hpolytope.h:21:7: warning: ‘Perr.HPolytope<point<Cartesian<double> > >::_d’ may be used uninitialized [-Wmaybe-uninitialized]
21 | class HPolytope{
| ^~~~~~~~~
include/generators/known_polytope_generators.h: In function ‘Polytope gen_skinny_cube(const unsigned int&, bool) [with Polytope = HPolytope<point<Cartesian<double> > >]’:
include/generators/known_polytope_generators.h:254:14: note: ‘Perr’ declared here
254 | Polytope Perr;
| ^~~~
In constructor ‘point<Cartesian<double> >::point(point<Cartesian<double> >&&)’,
inlined from ‘std::pair<_T1, _T2>::pair(std::pair<_T1, _T2>&&) [with _T1 = point<Cartesian<double> >; _T2 = double]’ at /usr/include/c++/15/bits/stl_pair.h:313:17,
inlined from ‘HPolytope<point<Cartesian<double> > >::HPolytope(HPolytope<point<Cartesian<double> > >&&)’ at include/convex_bodies/hpolytope.h:21:7,
inlined from ‘Polytope gen_skinny_cube(const unsigned int&, bool) [with Polytope = HPolytope<point<Cartesian<double> > >]’ at include/generators/known_polytope_generators.h:263:16:
include/cartesian_geom/point.h:17:7: warning: ‘*(point<Cartesian<double> >*)((char*)&Perr + offsetof(HPolytope<point<Cartesian<double> > >,HPolytope<point<Cartesian<double> > >::_inner_ball.std::pair<point<Cartesian<double> >, double>::<unnamed>)).point<Cartesian<double> >::d’ may be used uninitialized [-Wmaybe-uninitialized]
17 | class point
| ^~~~~
include/generators/known_polytope_generators.h: In function ‘Polytope gen_skinny_cube(const unsigned int&, bool) [with Polytope = HPolytope<point<Cartesian<double> > >]’:
include/generators/known_polytope_generators.h:254:14: note: ‘Perr’ declared here
254 | Polytope Perr;
| ^~~~
In file included from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Core:337,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Dense:1,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/RcppEigenForward.h:28,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/RcppEigen.h:25,
from poly_gen.cpp:11:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h: In function ‘static void Eigen::internal::selfadjoint_product_impl<Lhs, LhsMode, false, Rhs, 0, true>::run(Dest&, const Lhs&, const Rhs&, const Scalar&) [with Dest = Eigen::Block<Eigen::Matrix<double, -1, 1>, -1, 1, false>; Lhs = Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>; int LhsMode = 17; Rhs = Eigen::CwiseBinaryOp<Eigen::internal::scalar_product_op<double, double>, const Eigen::CwiseNullaryOp<Eigen::internal::scalar_constant_op<double>, const Eigen::Matrix<double, -1, 1> >, const Eigen::Block<Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, 1, true>, -1, 1, false> >]’:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h:229:7: warning: ‘result’ may be used uninitialized [-Wmaybe-uninitialized]
227 | internal::selfadjoint_matrix_vector_product<Scalar, Index, (internal::traits<ActualLhsTypeCleaned>::Flags&RowMajorBit) ? RowMajor : ColMajor,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
228 | int(LhsUpLo), bool(LhsBlasTraits::NeedToConjugate), bool(RhsBlasTraits::NeedToConjugate)>::run
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
229 | (
| ^
230 | lhs.rows(), // size
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
231 | &lhs.coeffRef(0,0), lhs.outerStride(), // lhs info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
232 | actualRhsPtr, // rhs info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
233 | actualDestPtr, // result info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
234 | actualAlpha // scale factor
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
235 | );
| ~
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h:41:6: note: by argument 4 of type ‘const double*’ to ‘static void Eigen::internal::selfadjoint_matrix_vector_product<Scalar, Index, StorageOrder, UpLo, ConjugateLhs, ConjugateRhs, Version>::run(Index, const Scalar*, Index, const Scalar*, Scalar*, Scalar) [with Scalar = double; Index = long int; int StorageOrder = 0; int UpLo = 1; bool ConjugateLhs = false; bool ConjugateRhs = false; int Version = 0]’ declared here
41 | void selfadjoint_matrix_vector_product<Scalar,Index,StorageOrder,UpLo,ConjugateLhs,ConjugateRhs,Version>::run(
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
In file included from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Core:341:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h: In function ‘static void Eigen::internal::trmv_selector<Mode, 1>::run(const Lhs&, const Rhs&, Dest&, const typename Dest::Scalar&) [with Lhs = Eigen::Transpose<const Eigen::Block<const Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>, -1, -1, false> >; Rhs = Eigen::Transpose<const Eigen::CwiseBinaryOp<Eigen::internal::scalar_product_op<double, double>, const Eigen::CwiseNullaryOp<Eigen::internal::scalar_constant_op<double>, const Eigen::Matrix<double, 1, -1> >, const Eigen::Transpose<const Eigen::Block<const Eigen::Block<const Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>, -1, 1, true>, -1, 1, false> > > >; Dest = Eigen::Transpose<Eigen::Block<Eigen::Block<Eigen::Matrix<double, -1, -1, 1, -1, -1>, 1, -1, true>, 1, -1, false> >; int Mode = 6]’:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h:332:12: warning: ‘result’ may be used uninitialized [-Wmaybe-uninitialized]
327 | internal::triangular_matrix_vector_product
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
328 | <Index,Mode,
| ~~~~~~~~~~~~
329 | LhsScalar, LhsBlasTraits::NeedToConjugate,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
330 | RhsScalar, RhsBlasTraits::NeedToConjugate,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
331 | RowMajor>
| ~~~~~~~~~
332 | ::run(actualLhs.rows(),actualLhs.cols(),
| ~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
333 | actualLhs.data(),actualLhs.outerStride(),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
334 | actualRhsPtr,1,
| ~~~~~~~~~~~~~~~
335 | dest.data(),dest.innerStride(),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
336 | actualAlpha);
| ~~~~~~~~~~~~
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h:105:24: note: by argument 5 of type ‘const double*’ to ‘static void Eigen::internal::triangular_matrix_vector_product<Index, Mode, LhsScalar, ConjLhs, RhsScalar, ConjRhs, 1, Version>::run(Index, Index, const LhsScalar*, Index, const RhsScalar*, Index, ResScalar*, Index, const ResScalar&) [with Index = long int; int Mode = 6; LhsScalar = double; bool ConjLhs = false; RhsScalar = double; bool ConjRhs = false; int Version = 0]’ declared here
105 | EIGEN_DONT_INLINE void triangular_matrix_vector_product<Index,Mode,LhsScalar,ConjLhs,RhsScalar,ConjRhs,RowMajor,Version>
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
g++ -std=gnu++17 -I"/data/gannet/ripley/R/R-devel/include" -DNDEBUG -Iexternal -Iexternal/lpsolve/headers/run_headers -Iexternal/minimum_ellipsoid -Iinclude -Iinclude/convex_bodies/spectrahedra -I'/data/gannet/ripley/R/test-dev/Rcpp/include' -I'/data/gannet/ripley/R/test-dev/RcppEigen/include' -I'/data/gannet/ripley/R/test-dev/BH/include' -I/usr/local/include -DBOOST_NO_AUTO_PTR -fpic -g -O2 -Wall -pedantic -mtune=native -Wno-ignored-attributes -Wno-parentheses -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -c sample_points.cpp -o sample_points.o
In file included from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Core:337,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Dense:1,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/RcppEigenForward.h:28,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/RcppEigen.h:25,
from rotating.cpp:11:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h: In function ‘static void Eigen::internal::selfadjoint_product_impl<Lhs, LhsMode, false, Rhs, 0, true>::run(Dest&, const Lhs&, const Rhs&, const Scalar&) [with Dest = Eigen::Block<Eigen::Matrix<double, -1, 1>, -1, 1, false>; Lhs = Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>; int LhsMode = 17; Rhs = Eigen::CwiseBinaryOp<Eigen::internal::scalar_product_op<double, double>, const Eigen::CwiseNullaryOp<Eigen::internal::scalar_constant_op<double>, const Eigen::Matrix<double, -1, 1> >, const Eigen::Block<Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, 1, true>, -1, 1, false> >]’:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h:229:7: warning: ‘result’ may be used uninitialized [-Wmaybe-uninitialized]
227 | internal::selfadjoint_matrix_vector_product<Scalar, Index, (internal::traits<ActualLhsTypeCleaned>::Flags&RowMajorBit) ? RowMajor : ColMajor,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
228 | int(LhsUpLo), bool(LhsBlasTraits::NeedToConjugate), bool(RhsBlasTraits::NeedToConjugate)>::run
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
229 | (
| ^
230 | lhs.rows(), // size
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
231 | &lhs.coeffRef(0,0), lhs.outerStride(), // lhs info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
232 | actualRhsPtr, // rhs info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
233 | actualDestPtr, // result info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
234 | actualAlpha // scale factor
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
235 | );
| ~
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h:41:6: note: by argument 4 of type ‘const double*’ to ‘static void Eigen::internal::selfadjoint_matrix_vector_product<Scalar, Index, StorageOrder, UpLo, ConjugateLhs, ConjugateRhs, Version>::run(Index, const Scalar*, Index, const Scalar*, Scalar*, Scalar) [with Scalar = double; Index = long int; int StorageOrder = 0; int UpLo = 1; bool ConjugateLhs = false; bool ConjugateRhs = false; int Version = 0]’ declared here
41 | void selfadjoint_matrix_vector_product<Scalar,Index,StorageOrder,UpLo,ConjugateLhs,ConjugateRhs,Version>::run(
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
In file included from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Core:341:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h: In function ‘static void Eigen::internal::trmv_selector<Mode, 1>::run(const Lhs&, const Rhs&, Dest&, const typename Dest::Scalar&) [with Lhs = Eigen::Transpose<const Eigen::Block<const Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>, -1, -1, false> >; Rhs = Eigen::Transpose<const Eigen::CwiseBinaryOp<Eigen::internal::scalar_product_op<double, double>, const Eigen::CwiseNullaryOp<Eigen::internal::scalar_constant_op<double>, const Eigen::Matrix<double, 1, -1> >, const Eigen::Transpose<const Eigen::Block<const Eigen::Block<const Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>, -1, 1, true>, -1, 1, false> > > >; Dest = Eigen::Transpose<Eigen::Block<Eigen::Block<Eigen::Matrix<double, -1, -1, 1, -1, -1>, 1, -1, true>, 1, -1, false> >; int Mode = 6]’:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h:332:12: warning: ‘result’ may be used uninitialized [-Wmaybe-uninitialized]
327 | internal::triangular_matrix_vector_product
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
328 | <Index,Mode,
| ~~~~~~~~~~~~
329 | LhsScalar, LhsBlasTraits::NeedToConjugate,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
330 | RhsScalar, RhsBlasTraits::NeedToConjugate,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
331 | RowMajor>
| ~~~~~~~~~
332 | ::run(actualLhs.rows(),actualLhs.cols(),
| ~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
333 | actualLhs.data(),actualLhs.outerStride(),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
334 | actualRhsPtr,1,
| ~~~~~~~~~~~~~~~
335 | dest.data(),dest.innerStride(),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
336 | actualAlpha);
| ~~~~~~~~~~~~
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h:105:24: note: by argument 5 of type ‘const double*’ to ‘static void Eigen::internal::triangular_matrix_vector_product<Index, Mode, LhsScalar, ConjLhs, RhsScalar, ConjRhs, 1, Version>::run(Index, Index, const LhsScalar*, Index, const RhsScalar*, Index, ResScalar*, Index, const ResScalar&) [with Index = long int; int Mode = 6; LhsScalar = double; bool ConjLhs = false; RhsScalar = double; bool ConjRhs = false; int Version = 0]’ declared here
105 | EIGEN_DONT_INLINE void triangular_matrix_vector_product<Index,Mode,LhsScalar,ConjLhs,RhsScalar,ConjRhs,RowMajor,Version>
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
In file included from sample_points.cpp:19:
include/volume/volume_cooling_gaussians.hpp: In function ‘NT get_next_gaussian(const Polytope&, Point&, const NT&, const unsigned int&, const NT&, const NT&, const unsigned int&, RandomNumberGenerator&)’:
include/volume/volume_cooling_gaussians.hpp:166:48: warning: typedef ‘viterator’ locally defined but not used [-Wunused-local-typedefs]
166 | typedef typename std::vector<NT>::iterator viterator;
| ^~~~~~~~~
include/volume/volume_cooling_gaussians.hpp: In function ‘void compute_annealing_schedule(const Polytope&, const NT&, const NT&, const NT&, const unsigned int&, const unsigned int&, const NT&, const NT&, std::vector<NT>&, RandomNumberGenerator&)’:
include/volume/volume_cooling_gaussians.hpp:221:35: warning: typedef ‘VT’ locally defined but not used [-Wunused-local-typedefs]
221 | typedef typename Polytope::VT VT;
| ^~
g++ -std=gnu++17 -I"/data/gannet/ripley/R/R-devel/include" -DNDEBUG -Iexternal -Iexternal/lpsolve/headers/run_headers -Iexternal/minimum_ellipsoid -Iinclude -Iinclude/convex_bodies/spectrahedra -I'/data/gannet/ripley/R/test-dev/Rcpp/include' -I'/data/gannet/ripley/R/test-dev/RcppEigen/include' -I'/data/gannet/ripley/R/test-dev/BH/include' -I/usr/local/include -DBOOST_NO_AUTO_PTR -fpic -g -O2 -Wall -pedantic -mtune=native -Wno-ignored-attributes -Wno-parentheses -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -c volume.cpp -o volume.o
sample_points.cpp: In function ‘Rcpp::NumericMatrix sample_points(Rcpp::Reference, int, Rcpp::Nullable<Rcpp::Vector<19> >, Rcpp::Nullable<Rcpp::Vector<19> >)’:
sample_points.cpp:172:8: warning: unused variable ‘radius’ [-Wunused-variable]
172 | NT radius = 1.0, L;
| ^~~~~~
In file included from include/random_walks/uniform_billiard_walk.hpp:18,
from include/random_walks/random_walks.hpp:16,
from sample_points.cpp:17:
include/convex_bodies/vpolytope.h: In instantiation of ‘std::pair<Point, typename Point::FT> VPolytope<Point>::ComputeInnerBall() [with Point = point<Cartesian<double> >; typename Point::FT = double]’:
sample_points.cpp:312:48: required from here
312 | InnerBall = VP.ComputeInnerBall();
| ~~~~~~~~~~~~~~~~~~~^~
include/convex_bodies/vpolytope.h:278:30: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
278 | for ( i=0; i < rpit->dimension(); i++){
| ~~^~~~~~~~~~~~~~~~~~~
include/convex_bodies/vpolytope.h: In instantiation of ‘bool VPolytope<Point>::get_points_for_rounding(PointList&) [with PointList = std::__cxx11::list<point<Cartesian<double> > >; Point = point<Cartesian<double> >]’:
include/convex_bodies/vpolytope.h:267:37: required from ‘std::pair<Point, typename Point::FT> VPolytope<Point>::ComputeInnerBall() [with Point = point<Cartesian<double> >; typename Point::FT = double]’
267 | if (!get_points_for_rounding(randPoints)) {
| ~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~
sample_points.cpp:312:48: required from here
312 | InnerBall = VP.ComputeInnerBall();
| ~~~~~~~~~~~~~~~~~~~^~
include/convex_bodies/vpolytope.h:408:30: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
408 | if (num_of_vertices()>20*_d) {
| ~~~~~~~~~~~~~~~~~^~~~~~
include/convex_bodies/vpolytope.h:411:22: warning: unused variable ‘j’ [-Wunused-variable]
411 | unsigned int j;
| ^
In file included from include/convex_bodies/vpolytope.h:18:
include/lp_oracles/vpolyoracles.h: In instantiation of ‘std::pair<_FIter, _FIter> intersect_double_line_Vpoly(const MT&, const Point&, const Point&, NT*, int*) [with NT = double; MT = Eigen::Matrix<double, -1, -1>; Point = point<Cartesian<double> >]’:
include/convex_bodies/vpolytope.h:297:50: required from ‘std::pair<Point, typename Point::FT> VPolytope<Point>::ComputeInnerBall() [with Point = point<Cartesian<double> >; typename Point::FT = double]’
297 | res = intersect_double_line_Vpoly<NT>(V, center, v, row, colno);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:312:48: required from here
312 | InnerBall = VP.ComputeInnerBall();
| ~~~~~~~~~~~~~~~~~~~^~
include/lp_oracles/vpolyoracles.h:311:8: warning: unused variable ‘res’ [-Wunused-variable]
311 | NT res;
| ^~~
In file included from include/convex_bodies/zpolytope.h:19,
from include/random_walks/uniform_billiard_walk.hpp:20:
include/lp_oracles/zpolyoracles.h: In instantiation of ‘bool memLP_Zonotope(const MT&, const Point&, NT*, int*) [with MT = Eigen::Matrix<double, -1, -1>; Point = point<Cartesian<double> >; NT = double]’:
include/convex_bodies/zpolytope.h:241:26: required from ‘int Zonotope<Point>::is_in(const Point&) const [with Point = point<Cartesian<double> >]’
241 | if(memLP_Zonotope(V, p, row_mem, colno_mem))
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:334:25: required from here
334 | if (ZP.is_in(StartingPoint) == 0)
| ~~~~~~~~^~~~~~~~~~~~~~~
include/lp_oracles/zpolyoracles.h:52:10: warning: unused variable ‘infinite’ [-Wunused-variable]
52 | REAL infinite = get_infinite(lp); /* will return 1.0e30 */
| ^~~~~~~~
In file included from include/convex_bodies/hpolytope.h:17,
from include/random_walks/uniform_billiard_walk.hpp:17:
include/lp_oracles/solve_lp.h: In instantiation of ‘Point PointInIntersection(MT, MT, Point, bool&) [with VT = Eigen::Matrix<double, -1, 1>; MT = Eigen::Matrix<double, -1, -1>; Point = point<Cartesian<double> >]’:
include/convex_bodies/vpolyintersectvpoly.h:128:32: required from ‘bool IntersectionOfVpoly<VPolytope, RNGType>::is_feasible() [with VPolytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
128 | PointInIntersection<VT>(P1.get_mat(), P2.get_mat(),
| ~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
129 | GetDirection<Point>::apply(k, rng), empty);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:352:35: required from here
352 | if (!VPcVP.is_feasible()) throw Rcpp::exception("Empty set!");
| ~~~~~~~~~~~~~~~~~^~
include/lp_oracles/solve_lp.h:204:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
204 | for (i = 0; i< d+2; ++i) {
| ~^~~~~
include/lp_oracles/solve_lp.h:206:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
206 | for(j=0; j<k1; j++){
| ~^~~
include/lp_oracles/solve_lp.h:208:18: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
208 | if (i==d) {
| ~^~~
include/lp_oracles/solve_lp.h:210:24: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
210 | } else if(i==d+1){
| ~^~~~~
include/lp_oracles/solve_lp.h:216:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
216 | for(j=0; j<k2; j++){
| ~^~~
include/lp_oracles/solve_lp.h:218:18: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
218 | if (i==d) {
| ~^~~
include/lp_oracles/solve_lp.h:220:24: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
220 | } else if(i==d+1){
| ~^~~~~
include/lp_oracles/solve_lp.h:229:17: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
229 | if(i==d || i==d+1) {
| ~^~~
include/lp_oracles/solve_lp.h:229:25: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
229 | if(i==d || i==d+1) {
| ~^~~~~
include/lp_oracles/solve_lp.h:285:17: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
285 | for ( j=0; j<k1; ++j) {
| ~^~~
In file included from include/cartesian_geom/cartesian_kernel.h:25,
from include/volume/volume_sequence_of_balls.hpp:24,
from sample_points.cpp:18:
include/cartesian_geom/point.h: In instantiation of ‘bool point<K>::operator==(point<K>&) const [with K = Cartesian<double>]’:
include/convex_bodies/vpolyintersectvpoly.h:154:22: required from ‘std::pair<typename VPolytope::PointType, typename VPolytope::NT> IntersectionOfVpoly<VPolytope, RNGType>::ComputeInnerBall() [with VPolytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; typename VPolytope::PointType = point<Cartesian<double> >; typename VPolytope::NT = double]’
154 | if (p==(*rvert)) {
| ~^~~~~~~~~~
sample_points.cpp:353:47: required from here
353 | InnerBall = VPcVP.ComputeInnerBall();
| ~~~~~~~~~~~~~~~~~~~~~~^~
include/cartesian_geom/point.h:157:21: warning: comparison of integer expressions of different signedness: ‘int’ and ‘const unsigned int’ [-Wsign-compare]
157 | for (i=0 ; i<d ; i++) {
| ~^~
In file included from sample_points.cpp:20:
include/sampling/sampling.hpp: In instantiation of ‘void uniform_sampling_boundary(PointList&, Polytope&, RandomNumberGenerator&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with WalkTypePolicy = BCDHRWalk; PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
sample_points.cpp:29:50: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
29 | uniform_sampling_boundary <BCDHRWalk>(randPoints, P, rng, walkL, numpoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
30 | StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:368:33: required from here
368 | sample_from_polytope(HP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
369 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/sampling/sampling.hpp:129:18: warning: unused variable ‘n’ [-Wunused-variable]
129 | unsigned int n = rnum / 2;
| ^
include/sampling/sampling.hpp: In instantiation of ‘void uniform_sampling_boundary(PointList&, Polytope&, RandomNumberGenerator&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with WalkTypePolicy = BRDHRWalk; PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
sample_points.cpp:32:50: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
32 | uniform_sampling_boundary <BRDHRWalk>(randPoints, P, rng, walkL, numpoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
33 | StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:368:33: required from here
368 | sample_from_polytope(HP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
369 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/sampling/sampling.hpp:129:18: warning: unused variable ‘n’ [-Wunused-variable]
129 | unsigned int n = rnum / 2;
| ^
include/sampling/sampling.hpp: In instantiation of ‘void uniform_sampling_boundary(PointList&, Polytope&, RandomNumberGenerator&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with WalkTypePolicy = BCDHRWalk; PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
sample_points.cpp:29:50: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
29 | uniform_sampling_boundary <BCDHRWalk>(randPoints, P, rng, walkL, numpoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
30 | StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:373:33: required from here
373 | sample_from_polytope(VP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
374 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/sampling/sampling.hpp:129:18: warning: unused variable ‘n’ [-Wunused-variable]
129 | unsigned int n = rnum / 2;
| ^
include/sampling/sampling.hpp: In instantiation of ‘void uniform_sampling_boundary(PointList&, Polytope&, RandomNumberGenerator&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with WalkTypePolicy = BRDHRWalk; PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
sample_points.cpp:32:50: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
32 | uniform_sampling_boundary <BRDHRWalk>(randPoints, P, rng, walkL, numpoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
33 | StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:373:33: required from here
373 | sample_from_polytope(VP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
374 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/sampling/sampling.hpp:129:18: warning: unused variable ‘n’ [-Wunused-variable]
129 | unsigned int n = rnum / 2;
| ^
include/sampling/sampling.hpp: In instantiation of ‘void uniform_sampling_boundary(PointList&, Polytope&, RandomNumberGenerator&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with WalkTypePolicy = BCDHRWalk; PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
sample_points.cpp:29:50: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
29 | uniform_sampling_boundary <BCDHRWalk>(randPoints, P, rng, walkL, numpoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
30 | StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:378:33: required from here
378 | sample_from_polytope(ZP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
379 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/sampling/sampling.hpp:129:18: warning: unused variable ‘n’ [-Wunused-variable]
129 | unsigned int n = rnum / 2;
| ^
include/sampling/sampling.hpp: In instantiation of ‘void uniform_sampling_boundary(PointList&, Polytope&, RandomNumberGenerator&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with WalkTypePolicy = BRDHRWalk; PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
sample_points.cpp:32:50: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
32 | uniform_sampling_boundary <BRDHRWalk>(randPoints, P, rng, walkL, numpoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
33 | StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:378:33: required from here
378 | sample_from_polytope(ZP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
379 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/sampling/sampling.hpp:129:18: warning: unused variable ‘n’ [-Wunused-variable]
129 | unsigned int n = rnum / 2;
| ^
include/sampling/sampling.hpp: In instantiation of ‘void uniform_sampling_boundary(PointList&, Polytope&, RandomNumberGenerator&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with WalkTypePolicy = BCDHRWalk; PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
sample_points.cpp:29:50: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
29 | uniform_sampling_boundary <BCDHRWalk>(randPoints, P, rng, walkL, numpoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
30 | StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:383:33: required from here
383 | sample_from_polytope(VPcVP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
384 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/sampling/sampling.hpp:129:18: warning: unused variable ‘n’ [-Wunused-variable]
129 | unsigned int n = rnum / 2;
| ^
include/sampling/sampling.hpp: In instantiation of ‘void uniform_sampling_boundary(PointList&, Polytope&, RandomNumberGenerator&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with WalkTypePolicy = BRDHRWalk; PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
sample_points.cpp:32:50: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
32 | uniform_sampling_boundary <BRDHRWalk>(randPoints, P, rng, walkL, numpoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
33 | StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:383:33: required from here
383 | sample_from_polytope(VPcVP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
384 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/sampling/sampling.hpp:129:18: warning: unused variable ‘n’ [-Wunused-variable]
129 | unsigned int n = rnum / 2;
| ^
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = HPolytope<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/sampling/random_point_generators.hpp:39:23: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&, const Parameters&) [with Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Parameters = BilliardWalk::parameters; Walk = BilliardWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
39 | walk.apply(P, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~
include/sampling/sampling.hpp:89:32: required from ‘void uniform_sampling(PointList&, Polytope&, RandomNumberGenerator&, WalkTypePolicy&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; WalkTypePolicy = BilliardWalk; Point = point<Cartesian<double> >]’
89 | RandomPointGenerator::apply(P, p, nburns, walk_len, randPoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
90 | push_back_policy, rng, WalkType.param);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:54:29: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
54 | uniform_sampling(randPoints, P, rng, WalkType, walkL, numpoints, StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:368:33: required from here
368 | sample_from_polytope(HP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
369 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = VPolytope<point<Cartesian<double> > >; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/sampling/random_point_generators.hpp:39:23: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&, const Parameters&) [with Polytope = VPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Parameters = BilliardWalk::parameters; Walk = BilliardWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
39 | walk.apply(P, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~
include/sampling/sampling.hpp:89:32: required from ‘void uniform_sampling(PointList&, Polytope&, RandomNumberGenerator&, WalkTypePolicy&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; WalkTypePolicy = BilliardWalk; Point = point<Cartesian<double> >]’
89 | RandomPointGenerator::apply(P, p, nburns, walk_len, randPoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
90 | push_back_policy, rng, WalkType.param);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:54:29: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
54 | uniform_sampling(randPoints, P, rng, WalkType, walkL, numpoints, StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:373:33: required from here
373 | sample_from_polytope(VP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
374 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/sampling/random_point_generators.hpp:39:23: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&, const Parameters&) [with Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Parameters = BilliardWalk::parameters; Walk = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
39 | walk.apply(P, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~
include/sampling/sampling.hpp:89:32: required from ‘void uniform_sampling(PointList&, Polytope&, RandomNumberGenerator&, WalkTypePolicy&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; WalkTypePolicy = BilliardWalk; Point = point<Cartesian<double> >]’
89 | RandomPointGenerator::apply(P, p, nburns, walk_len, randPoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
90 | push_back_policy, rng, WalkType.param);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:54:29: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
54 | uniform_sampling(randPoints, P, rng, WalkType, walkL, numpoints, StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:378:33: required from here
378 | sample_from_polytope(ZP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
379 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/sampling/random_point_generators.hpp:39:23: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&, const Parameters&) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Parameters = BilliardWalk::parameters; Walk = BilliardWalk::Walk<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
39 | walk.apply(P, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~
include/sampling/sampling.hpp:89:32: required from ‘void uniform_sampling(PointList&, Polytope&, RandomNumberGenerator&, WalkTypePolicy&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; WalkTypePolicy = BilliardWalk; Point = point<Cartesian<double> >]’
89 | RandomPointGenerator::apply(P, p, nburns, walk_len, randPoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
90 | push_back_policy, rng, WalkType.param);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:54:29: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
54 | uniform_sampling(randPoints, P, rng, WalkType, walkL, numpoints, StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:383:33: required from here
383 | sample_from_polytope(VPcVP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
384 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/convex_bodies/hpolytope.h: In instantiation of ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&, VT&, VT&, const NT&, bool) const [with Point = point<Cartesian<double> >; typename Point::FT = double; VT = Eigen::Matrix<double, -1, 1>; NT = double]’:
include/random_walks/boundary_rdhr_walk.hpp:48:59: required from ‘void BRDHRWalk::Walk<Polytope, RandomNumberGenerator>::apply(const BallPolytope&, Point&, Point&, const unsigned int&, RandomNumberGenerator&) [with BallPolytope = HPolytope<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
48 | std::pair<NT, NT> bpair = P.line_intersect(_p, v, _lamdas, _Av,
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
49 | _lambda);
| ~~~~~~~~
include/sampling/random_point_generators.hpp:156:23: required from ‘static void BoundaryRandomPointGenerator<Walk>::apply(const Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = BRDHRWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
156 | walk.apply(P, p1, p2, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/sampling/sampling.hpp:125:40: required from ‘void uniform_sampling_boundary(PointList&, Polytope&, RandomNumberGenerator&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with WalkTypePolicy = BRDHRWalk; PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
125 | BoundaryRandomPointGenerator::apply(P, p, nburns, walk_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~
126 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:32:50: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
32 | uniform_sampling_boundary <BRDHRWalk>(randPoints, P, rng, walkL, numpoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
33 | StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:368:33: required from here
368 | sample_from_polytope(HP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
369 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/hpolytope.h:313:12: warning: unused variable ‘mult’ [-Wunused-variable]
313 | NT mult;
| ^~~~
include/convex_bodies/hpolytope.h:315:22: warning: unused variable ‘j’ [-Wunused-variable]
315 | unsigned int j;
| ^
include/convex_bodies/hpolytope.h: In instantiation of ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&) const [with Point = point<Cartesian<double> >; typename Point::FT = double]’:
include/random_walks/gaussian_rdhr_walk.hpp:102:57: required from ‘void GaussianRDHRWalk::Walk<Polytope, RandomNumberGenerator>::apply(const BallPolytope&, Point&, const NT&, const unsigned int&, RandomNumberGenerator&) [with BallPolytope = HPolytope<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >; NT = double]’
102 | std::pair <NT, NT> dbpair = P.line_intersect(p, v);
| ~~~~~~~~~~~~~~~~^~~~~~
include/sampling/random_point_generators.hpp:96:23: required from ‘static void GaussianRandomPointGenerator<Walk>::apply(const Polytope&, Point&, const NT&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; PointList = std::__cxx11::list<point<Cartesian<double> > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = GaussianRDHRWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
96 | walk.apply(P, p, a_i, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/sampling/sampling.hpp:167:32: required from ‘void gaussian_sampling(PointList&, Polytope&, RandomNumberGenerator&, const unsigned int&, const unsigned int&, const NT&, const Point&, const unsigned int&) [with WalkTypePolicy = GaussianRDHRWalk; PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double; Point = point<Cartesian<double> >]’
167 | RandomPointGenerator::apply(P, p, a, nburns, walk_len, randPoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
168 | push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:45:48: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
45 | gaussian_sampling<GaussianRDHRWalk>(randPoints, P, rng, walkL, numpoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
46 | a, StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:368:33: required from here
368 | sample_from_polytope(HP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
369 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/hpolytope.h:236:22: warning: unused variable ‘j’ [-Wunused-variable]
236 | unsigned int j;
| ^
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = HPolytope<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:231:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&, const BilliardWalk::parameters&) [with GenericPolytope = HPolytope<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
231 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/sampling/random_point_generators.hpp:36:14: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&, const Parameters&) [with Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Parameters = BilliardWalk::parameters; Walk = BilliardWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
36 | Walk walk(P, p, rng, parameters);
| ^~~~
include/sampling/sampling.hpp:89:32: required from ‘void uniform_sampling(PointList&, Polytope&, RandomNumberGenerator&, WalkTypePolicy&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; WalkTypePolicy = BilliardWalk; Point = point<Cartesian<double> >]’
89 | RandomPointGenerator::apply(P, p, nburns, walk_len, randPoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
90 | push_back_policy, rng, WalkType.param);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:54:29: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
54 | uniform_sampling(randPoints, P, rng, WalkType, walkL, numpoints, StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:368:33: required from here
368 | sample_from_polytope(HP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
369 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = VPolytope<point<Cartesian<double> > >; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:231:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&, const BilliardWalk::parameters&) [with GenericPolytope = VPolytope<point<Cartesian<double> > >; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
231 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/sampling/random_point_generators.hpp:36:14: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&, const Parameters&) [with Polytope = VPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Parameters = BilliardWalk::parameters; Walk = BilliardWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
36 | Walk walk(P, p, rng, parameters);
| ^~~~
include/sampling/sampling.hpp:89:32: required from ‘void uniform_sampling(PointList&, Polytope&, RandomNumberGenerator&, WalkTypePolicy&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; WalkTypePolicy = BilliardWalk; Point = point<Cartesian<double> >]’
89 | RandomPointGenerator::apply(P, p, nburns, walk_len, randPoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
90 | push_back_policy, rng, WalkType.param);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:54:29: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
54 | uniform_sampling(randPoints, P, rng, WalkType, walkL, numpoints, StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:373:33: required from here
373 | sample_from_polytope(VP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
374 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘static NT compute_diameter<Zonotope<Point> >::compute(const Zonotope<Point>&) [with NT = double; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:230:51: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&, const BilliardWalk::parameters&) [with GenericPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
229 | : compute_diameter<GenericPolytope>
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
230 | ::template compute<NT>(P);
| ~~~~~~~~~~~~~~~~~~~~~~^~~
include/sampling/random_point_generators.hpp:36:14: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&, const Parameters&) [with Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Parameters = BilliardWalk::parameters; Walk = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
36 | Walk walk(P, p, rng, parameters);
| ^~~~
include/sampling/sampling.hpp:89:32: required from ‘void uniform_sampling(PointList&, Polytope&, RandomNumberGenerator&, WalkTypePolicy&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; WalkTypePolicy = BilliardWalk; Point = point<Cartesian<double> >]’
89 | RandomPointGenerator::apply(P, p, nburns, walk_len, randPoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
90 | push_back_policy, rng, WalkType.param);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:54:29: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
54 | uniform_sampling(randPoints, P, rng, WalkType, walkL, numpoints, StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:378:33: required from here
378 | sample_from_polytope(ZP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
379 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:84:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
84 | for (int i = 0; i < P.dimension(); ++i) {
| ~~^~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:231:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&, const BilliardWalk::parameters&) [with GenericPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
231 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/sampling/random_point_generators.hpp:36:14: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&, const Parameters&) [with Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Parameters = BilliardWalk::parameters; Walk = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
36 | Walk walk(P, p, rng, parameters);
| ^~~~
include/sampling/sampling.hpp:89:32: required from ‘void uniform_sampling(PointList&, Polytope&, RandomNumberGenerator&, WalkTypePolicy&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; WalkTypePolicy = BilliardWalk; Point = point<Cartesian<double> >]’
89 | RandomPointGenerator::apply(P, p, nburns, walk_len, randPoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
90 | push_back_policy, rng, WalkType.param);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:54:29: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
54 | uniform_sampling(randPoints, P, rng, WalkType, walkL, numpoints, StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:378:33: required from here
378 | sample_from_polytope(ZP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
379 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:231:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&, const BilliardWalk::parameters&) [with GenericPolytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
231 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/sampling/random_point_generators.hpp:36:14: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&, const Parameters&) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Parameters = BilliardWalk::parameters; Walk = BilliardWalk::Walk<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
36 | Walk walk(P, p, rng, parameters);
| ^~~~
include/sampling/sampling.hpp:89:32: required from ‘void uniform_sampling(PointList&, Polytope&, RandomNumberGenerator&, WalkTypePolicy&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; WalkTypePolicy = BilliardWalk; Point = point<Cartesian<double> >]’
89 | RandomPointGenerator::apply(P, p, nburns, walk_len, randPoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
90 | push_back_policy, rng, WalkType.param);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:54:29: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
54 | uniform_sampling(randPoints, P, rng, WalkType, walkL, numpoints, StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:383:33: required from here
383 | sample_from_polytope(VPcVP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
384 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
include/lp_oracles/zpolyoracles.h: In instantiation of ‘std::pair<_FIter, _FIter> intersect_line_zono(const MT&, const Point&, const Point&, NT*, int*) [with NT = double; MT = Eigen::Matrix<double, -1, -1>; Point = point<Cartesian<double> >]’:
include/convex_bodies/zpolytope.h:296:35: required from ‘std::pair<typename Point::FT, typename Point::FT> Zonotope<Point>::line_intersect(const Point&, const Point&, const VT&, const VT&, const NT&) const [with Point = point<Cartesian<double> >; typename Point::FT = double; VT = Eigen::Matrix<double, -1, 1>; NT = double]’
296 | return intersect_line_zono(V, r, v, conv_comb, colno);
| ~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/boundary_rdhr_walk.hpp:48:59: required from ‘void BRDHRWalk::Walk<Polytope, RandomNumberGenerator>::apply(const BallPolytope&, Point&, Point&, const unsigned int&, RandomNumberGenerator&) [with BallPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
48 | std::pair<NT, NT> bpair = P.line_intersect(_p, v, _lamdas, _Av,
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
49 | _lambda);
| ~~~~~~~~
include/sampling/random_point_generators.hpp:156:23: required from ‘static void BoundaryRandomPointGenerator<Walk>::apply(const Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = BRDHRWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
156 | walk.apply(P, p1, p2, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/sampling/sampling.hpp:125:40: required from ‘void uniform_sampling_boundary(PointList&, Polytope&, RandomNumberGenerator&, const unsigned int&, const unsigned int&, const Point&, const unsigned int&) [with WalkTypePolicy = BRDHRWalk; PointList = std::__cxx11::list<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
125 | BoundaryRandomPointGenerator::apply(P, p, nburns, walk_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~
126 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:32:50: required from ‘void sample_from_polytope(Polytope&, RNGType&, PointList&, const unsigned int&, const unsigned int&, const bool&, const NT&, const NT&, const bool&, const Point&, const unsigned int&, const bool&, const bool&, const bool&, const bool&, const bool&) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; PointList = std::__cxx11::list<point<Cartesian<double> > >; NT = double; Point = point<Cartesian<double> >]’
32 | uniform_sampling_boundary <BRDHRWalk>(randPoints, P, rng, walkL, numpoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
33 | StartingPoint, nburns);
| ~~~~~~~~~~~~~~~~~~~~~~
sample_points.cpp:378:33: required from here
378 | sample_from_polytope(ZP, rng, randPoints, walkL, numpoints, gaussian, a, L, boundary, StartingPoint, nburns,
| ~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
379 | set_L, cdhr, rdhr, billiard, ball_walk);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/lp_oracles/zpolyoracles.h:140:8: warning: unused variable ‘res’ [-Wunused-variable]
140 | NT res;
| ^~~
g++ -std=gnu++17 -I"/data/gannet/ripley/R/R-devel/include" -DNDEBUG -Iexternal -Iexternal/lpsolve/headers/run_headers -Iexternal/minimum_ellipsoid -Iinclude -Iinclude/convex_bodies/spectrahedra -I'/data/gannet/ripley/R/test-dev/Rcpp/include' -I'/data/gannet/ripley/R/test-dev/RcppEigen/include' -I'/data/gannet/ripley/R/test-dev/BH/include' -I/usr/local/include -DBOOST_NO_AUTO_PTR -fpic -g -O2 -Wall -pedantic -mtune=native -Wno-ignored-attributes -Wno-parentheses -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -c write_sdpa_format_file.cpp -o write_sdpa_format_file.o
In file included from volume.cpp:17:
include/volume/volume_cooling_gaussians.hpp: In function ‘NT get_next_gaussian(const Polytope&, Point&, const NT&, const unsigned int&, const NT&, const NT&, const unsigned int&, RandomNumberGenerator&)’:
include/volume/volume_cooling_gaussians.hpp:166:48: warning: typedef ‘viterator’ locally defined but not used [-Wunused-local-typedefs]
166 | typedef typename std::vector<NT>::iterator viterator;
| ^~~~~~~~~
include/volume/volume_cooling_gaussians.hpp: In function ‘void compute_annealing_schedule(const Polytope&, const NT&, const NT&, const NT&, const unsigned int&, const unsigned int&, const NT&, const NT&, std::vector<NT>&, RandomNumberGenerator&)’:
include/volume/volume_cooling_gaussians.hpp:221:35: warning: typedef ‘VT’ locally defined but not used [-Wunused-local-typedefs]
221 | typedef typename Polytope::VT VT;
| ^~
In file included from volume.cpp:20:
include/volume/volume_cooling_balls.hpp: In function ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&)’:
include/volume/volume_cooling_balls.hpp:707:35: warning: typedef ‘VT’ locally defined but not used [-Wunused-local-typedefs]
707 | typedef typename Polytope::VT VT;
| ^~
include/volume/volume_cooling_balls.hpp:708:31: warning: typedef ‘PointList’ locally defined but not used [-Wunused-local-typedefs]
708 | typedef std::list <Point> PointList;
| ^~~~~~~~~
In file included from volume.cpp:21:
include/volume/volume_cooling_hpoly.hpp: In function ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&)’:
include/volume/volume_cooling_hpoly.hpp:269:31: warning: typedef ‘PointList’ locally defined but not used [-Wunused-local-typedefs]
269 | typedef std::list <Point> PointList;
| ^~~~~~~~~
volume.cpp: In function ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int)’:
volume.cpp:34:30: warning: typedef ‘Hpolytope’ locally defined but not used [-Wunused-local-typedefs]
34 | typedef HPolytope<Point> Hpolytope;
| ^~~~~~~~~
include/volume/volume_cooling_hpoly.hpp: In instantiation of ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
volume.cpp:286:69: required from here
286 | return volume_cooling_hpoly<CDHRWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:359:27: warning: comparison of integer expressions of different signedness: ‘int’ and ‘std::vector<HPolytope<point<Cartesian<double> > >, std::allocator<HPolytope<point<Cartesian<double> > > > >::size_type’ {aka ‘long unsigned int’} [-Wsign-compare]
359 | for (int i = 0; i < HPolySet.size()-1; ++i) {
| ~~^~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp: In instantiation of ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = RDHRWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
volume.cpp:288:69: required from here
288 | return volume_cooling_hpoly<RDHRWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:359:27: warning: comparison of integer expressions of different signedness: ‘int’ and ‘std::vector<HPolytope<point<Cartesian<double> > >, std::allocator<HPolytope<point<Cartesian<double> > > > >::size_type’ {aka ‘long unsigned int’} [-Wsign-compare]
359 | for (int i = 0; i < HPolySet.size()-1; ++i) {
| ~~^~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp: In instantiation of ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BallWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
volume.cpp:290:69: required from here
290 | return volume_cooling_hpoly<BallWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:359:27: warning: comparison of integer expressions of different signedness: ‘int’ and ‘std::vector<HPolytope<point<Cartesian<double> > >, std::allocator<HPolytope<point<Cartesian<double> > > > >::size_type’ {aka ‘long unsigned int’} [-Wsign-compare]
359 | for (int i = 0; i < HPolySet.size()-1; ++i) {
| ~~^~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp: In instantiation of ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
volume.cpp:292:73: required from here
292 | return volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:359:27: warning: comparison of integer expressions of different signedness: ‘int’ and ‘std::vector<HPolytope<point<Cartesian<double> > >, std::allocator<HPolytope<point<Cartesian<double> > > > >::size_type’ {aka ‘long unsigned int’} [-Wsign-compare]
359 | for (int i = 0; i < HPolySet.size()-1; ++i) {
| ~~^~~~~~~~~~~~~~~~~~~
In file included from include/volume/volume_sequence_of_balls.hpp:33,
from volume.cpp:18:
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = CDHRWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
volume.cpp:43:57: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
43 | round_val = round_polytope<CDHRWalk, MT, VT>(P, InnerBall, 10 + 10 * n, rng).second;
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
volume.cpp:45:61: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
45 | round_val = round_polytope<BilliardWalk, MT, VT>(P, InnerBall, 2, rng).second;
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
In file included from include/random_walks/uniform_billiard_walk.hpp:18,
from include/random_walks/random_walks.hpp:16,
from volume.cpp:16:
include/convex_bodies/vpolytope.h: In instantiation of ‘std::pair<Point, typename Point::FT> VPolytope<Point>::ComputeInnerBall() [with Point = point<Cartesian<double> >; typename Point::FT = double]’:
volume.cpp:40:60: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
40 | std::pair<Point, NT> InnerBall = P.ComputeInnerBall();
| ~~~~~~~~~~~~~~~~~~^~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/vpolytope.h:278:30: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
278 | for ( i=0; i < rpit->dimension(); i++){
| ~~^~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = CDHRWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = VPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
volume.cpp:43:57: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
43 | round_val = round_polytope<CDHRWalk, MT, VT>(P, InnerBall, 10 + 10 * n, rng).second;
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = VPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
volume.cpp:45:61: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
45 | round_val = round_polytope<BilliardWalk, MT, VT>(P, InnerBall, 2, rng).second;
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp: In instantiation of ‘bool get_first_poly(Zonotope&, HPolytope&, NT&, const cooling_ball_parameters<NT>&, RNG&, VT&) [with RandomPointGenerator = RandomPointGenerator<CDHRWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; HPolytope = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; VT = Eigen::Matrix<double, -1, 1>]’:
include/volume/volume_cooling_hpoly.hpp:297:51: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
297 | if ( !get_first_poly<CdhrRandomPointGenerator>(P, HP, ratio, parameters, rng, b_max) )
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:286:69: required from here
286 | return volume_cooling_hpoly<CDHRWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:53:16: warning: comparison of integer expressions of different signedness: ‘int’ and ‘const unsigned int’ [-Wsign-compare]
53 | while(iter <= max_iterarions) {
| ~~~~~^~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:45:46: warning: unused variable ‘N’ [-Wunused-variable]
45 | int n = P.dimension(), m = b_max.size(), N = 1200, iter = 1, count = 0;
| ^
include/volume/volume_cooling_hpoly.hpp:45:66: warning: unused variable ‘count’ [-Wunused-variable]
45 | int n = P.dimension(), m = b_max.size(), N = 1200, iter = 1, count = 0;
| ^~~~~
include/volume/volume_cooling_hpoly.hpp:47:19: warning: unused variable ‘print’ [-Wunused-variable]
47 | bool too_few, print = false;
| ^~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = CDHRWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = HPolytope<point<Cartesian<double> > >; PolyBall2 = Zonotope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_hpoly.hpp:332:56: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
332 | vol *= estimate_ratio_interval<CdhrWalk, Point>(HP, P, ratio, er0, parameters.win_len, 1200, prob, 10+10*n, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:286:69: required from here
286 | return volume_cooling_hpoly<CDHRWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = CDHRWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_hpoly.hpp:341:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
341 | vol = vol / estimate_ratio_interval<WalkType, Point>(P, HP, ratios[0], er1, parameters.win_len, N_times_nu,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
342 | prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:286:69: required from here
286 | return volume_cooling_hpoly<CDHRWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = CDHRWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_hpoly.hpp:363:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
363 | vol = vol / estimate_ratio_interval<WalkType, Point>(zb1, b2, ratios[i], er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
364 | N_times_nu, prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:286:69: required from here
286 | return volume_cooling_hpoly<CDHRWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = RDHRWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_hpoly.hpp:341:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = RDHRWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
341 | vol = vol / estimate_ratio_interval<WalkType, Point>(P, HP, ratios[0], er1, parameters.win_len, N_times_nu,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
342 | prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:288:69: required from here
288 | return volume_cooling_hpoly<RDHRWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = RDHRWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_hpoly.hpp:363:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = RDHRWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
363 | vol = vol / estimate_ratio_interval<WalkType, Point>(zb1, b2, ratios[i], er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
364 | N_times_nu, prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:288:69: required from here
288 | return volume_cooling_hpoly<RDHRWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BallWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_hpoly.hpp:341:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BallWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
341 | vol = vol / estimate_ratio_interval<WalkType, Point>(P, HP, ratios[0], er1, parameters.win_len, N_times_nu,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
342 | prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:290:69: required from here
290 | return volume_cooling_hpoly<BallWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BallWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_hpoly.hpp:363:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BallWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
363 | vol = vol / estimate_ratio_interval<WalkType, Point>(zb1, b2, ratios[i], er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
364 | N_times_nu, prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:290:69: required from here
290 | return volume_cooling_hpoly<BallWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_hpoly.hpp:341:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
341 | vol = vol / estimate_ratio_interval<WalkType, Point>(P, HP, ratios[0], er1, parameters.win_len, N_times_nu,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
342 | prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:292:73: required from here
292 | return volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_hpoly.hpp:363:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
363 | vol = vol / estimate_ratio_interval<WalkType, Point>(zb1, b2, ratios[i], er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
364 | N_times_nu, prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:292:73: required from here
292 | return volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = CDHRWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
volume.cpp:43:57: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
43 | round_val = round_polytope<CDHRWalk, MT, VT>(P, InnerBall, 10 + 10 * n, rng).second;
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:295:34: required from here
295 | return generic_volume(ZP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
296 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
volume.cpp:45:61: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
45 | round_val = round_polytope<BilliardWalk, MT, VT>(P, InnerBall, 2, rng).second;
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
volume.cpp:295:34: required from here
295 | return generic_volume(ZP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
296 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
In file included from include/convex_bodies/hpolytope.h:17,
from include/random_walks/uniform_billiard_walk.hpp:17:
include/lp_oracles/solve_lp.h: In instantiation of ‘Point PointInIntersection(MT, MT, Point, bool&) [with VT = Eigen::Matrix<double, -1, 1>; MT = Eigen::Matrix<double, -1, -1>; Point = point<Cartesian<double> >]’:
include/convex_bodies/vpolyintersectvpoly.h:128:32: required from ‘bool IntersectionOfVpoly<VPolytope, RNGType>::is_feasible() [with VPolytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
128 | PointInIntersection<VT>(P1.get_mat(), P2.get_mat(),
| ~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
129 | GetDirection<Point>::apply(k, rng), empty);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:312:35: required from here
312 | if (!VPcVP.is_feasible()) throw Rcpp::exception("Empty set!");
| ~~~~~~~~~~~~~~~~~^~
include/lp_oracles/solve_lp.h:204:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
204 | for (i = 0; i< d+2; ++i) {
| ~^~~~~
include/lp_oracles/solve_lp.h:206:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
206 | for(j=0; j<k1; j++){
| ~^~~
include/lp_oracles/solve_lp.h:208:18: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
208 | if (i==d) {
| ~^~~
include/lp_oracles/solve_lp.h:210:24: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
210 | } else if(i==d+1){
| ~^~~~~
include/lp_oracles/solve_lp.h:216:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
216 | for(j=0; j<k2; j++){
| ~^~~
include/lp_oracles/solve_lp.h:218:18: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
218 | if (i==d) {
| ~^~~
include/lp_oracles/solve_lp.h:220:24: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
220 | } else if(i==d+1){
| ~^~~~~
include/lp_oracles/solve_lp.h:229:17: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
229 | if(i==d || i==d+1) {
| ~^~~
include/lp_oracles/solve_lp.h:229:25: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
229 | if(i==d || i==d+1) {
| ~^~~~~
include/lp_oracles/solve_lp.h:285:17: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
285 | for ( j=0; j<k1; ++j) {
| ~^~~
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = CDHRWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
volume.cpp:43:57: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
43 | round_val = round_polytope<CDHRWalk, MT, VT>(P, InnerBall, 10 + 10 * n, rng).second;
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
volume.cpp:45:61: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
45 | round_val = round_polytope<BilliardWalk, MT, VT>(P, InnerBall, 2, rng).second;
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const ball&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, RNG&) [with Point = point<Cartesian<double> >; ball = Ball<point<Cartesian<double> > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:761:47: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
761 | : estimate_ratio_interval<Point>(*(BallSet.end() - 1),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
762 | P, *(ratios.end() - 1),
| ~~~~~~~~~~~~~~~~~~~~~~~
763 | er0, parameters.win_len, 1200,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
764 | prob, rng);
| ~~~~~~~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:630:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
630 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = CDHRWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = HPolytope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = CDHRWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<HPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = RDHRWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = HPolytope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = RDHRWalk; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:62:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
62 | vol = volume_cooling_balls<RDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = RDHRWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<HPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = RDHRWalk; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:62:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
62 | vol = volume_cooling_balls<RDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BallWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = HPolytope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BallWalk; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:64:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
64 | vol = volume_cooling_balls<BallWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BallWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<HPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BallWalk; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:64:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
64 | vol = volume_cooling_balls<BallWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = HPolytope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:66:53: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
66 | vol = volume_cooling_balls<BilliardWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<HPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:66:53: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
66 | vol = volume_cooling_balls<BilliardWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/convex_bodies/vpolytope.h: In instantiation of ‘bool VPolytope<Point>::get_points_for_rounding(PointList&) [with PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; Point = point<Cartesian<double> >]’:
include/convex_bodies/vpolytope.h:267:37: required from ‘std::pair<Point, typename Point::FT> VPolytope<Point>::ComputeInnerBall() [with Point = point<Cartesian<double> >; typename Point::FT = double]’
267 | if (!get_points_for_rounding(randPoints)) {
| ~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~
volume.cpp:40:60: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
40 | std::pair<Point, NT> InnerBall = P.ComputeInnerBall();
| ~~~~~~~~~~~~~~~~~~^~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/vpolytope.h:408:30: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
408 | if (num_of_vertices()>20*_d) {
| ~~~~~~~~~~~~~~~~~^~~~~~
include/convex_bodies/vpolytope.h:411:22: warning: unused variable ‘j’ [-Wunused-variable]
411 | unsigned int j;
| ^
In file included from include/convex_bodies/vpolytope.h:18:
include/lp_oracles/vpolyoracles.h: In instantiation of ‘std::pair<_FIter, _FIter> intersect_double_line_Vpoly(const MT&, const Point&, const Point&, NT*, int*) [with NT = double; MT = Eigen::Matrix<double, -1, -1>; Point = point<Cartesian<double> >]’:
include/convex_bodies/vpolytope.h:297:50: required from ‘std::pair<Point, typename Point::FT> VPolytope<Point>::ComputeInnerBall() [with Point = point<Cartesian<double> >; typename Point::FT = double]’
297 | res = intersect_double_line_Vpoly<NT>(V, center, v, row, colno);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:40:60: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
40 | std::pair<Point, NT> InnerBall = P.ComputeInnerBall();
| ~~~~~~~~~~~~~~~~~~^~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/lp_oracles/vpolyoracles.h:311:8: warning: unused variable ‘res’ [-Wunused-variable]
311 | NT res;
| ^~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const ball&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, RNG&) [with Point = point<Cartesian<double> >; ball = Ball<point<Cartesian<double> > >; PolyBall2 = VPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:761:47: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
761 | : estimate_ratio_interval<Point>(*(BallSet.end() - 1),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
762 | P, *(ratios.end() - 1),
| ~~~~~~~~~~~~~~~~~~~~~~~
763 | er0, parameters.win_len, 1200,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
764 | prob, rng);
| ~~~~~~~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:630:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
630 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = CDHRWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = VPolytope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = CDHRWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<VPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = RDHRWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = VPolytope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = RDHRWalk; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:62:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
62 | vol = volume_cooling_balls<RDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = RDHRWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<VPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = RDHRWalk; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:62:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
62 | vol = volume_cooling_balls<RDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BallWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = VPolytope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BallWalk; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:64:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
64 | vol = volume_cooling_balls<BallWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BallWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<VPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BallWalk; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:64:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
64 | vol = volume_cooling_balls<BallWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = VPolytope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:66:53: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
66 | vol = volume_cooling_balls<BilliardWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<VPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:66:53: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
66 | vol = volume_cooling_balls<BilliardWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp: In instantiation of ‘bool get_next_zonoball(std::vector<WeightType>&, HPolytope&, const VT&, const VT&, PointList&, std::vector<NT>&, const cooling_ball_parameters<NT>&) [with Zonotope = Zonotope<point<Cartesian<double> > >; HPolytope = HPolytope<point<Cartesian<double> > >; VT = Eigen::Matrix<double, -1, 1>; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; NT = double]’:
include/volume/volume_cooling_hpoly.hpp:181:38: required from ‘bool get_sequence_of_zonopolys(Zonotope&, const HPolytope&, std::vector<NT>&, std::vector<NT>&, const VT&, const unsigned int&, const unsigned int&, const cooling_ball_parameters<NT>&, RNG&) [with RandomPointGenerator = RandomPointGenerator<CDHRWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> > >; ZonoHP = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; Zonotope = Zonotope<point<Cartesian<double> > >; HPolytope = HPolytope<point<Cartesian<double> > >; VT = Eigen::Matrix<double, -1, 1>; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
181 | if ( !get_next_zonoball<Zonotope>(HPolySet, HP2, b_max, HP.get_vec(),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
182 | randPoints, ratios, parameters))
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:309:24: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
308 | if ( !get_sequence_of_zonopolys<ZonoRandomPointGenerator, ZonoHP>
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
309 | (P, HP, HPolySet, ratios,
| ^~~~~~~~~~~~~~~~~~~~~~~~~
310 | b_max, N_times_nu, walk_length, parameters, rng) )
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:286:69: required from here
286 | return volume_cooling_hpoly<CDHRWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:113:17: warning: comparison of integer expressions of different signedness: ‘int’ and ‘const unsigned int’ [-Wsign-compare]
113 | while (iter <= max_iterarions) {
| ~~~~~^~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:108:9: warning: unused variable ‘n’ [-Wunused-variable]
108 | int n = HP2.dimension(), iter = 1;
| ^
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/volume/volume_cooling_balls.hpp:675:19: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
675 | walk.apply(Pb1, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:341:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
341 | vol = vol / estimate_ratio_interval<WalkType, Point>(P, HP, ratios[0], er1, parameters.win_len, N_times_nu,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
342 | prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:292:73: required from here
292 | return volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/volume/volume_cooling_balls.hpp:675:19: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
675 | walk.apply(Pb1, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:363:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
363 | vol = vol / estimate_ratio_interval<WalkType, Point>(zb1, b2, ratios[i], er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
364 | N_times_nu, prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:292:73: required from here
292 | return volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const ball&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, RNG&) [with Point = point<Cartesian<double> >; ball = Ball<point<Cartesian<double> > >; PolyBall2 = Zonotope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:761:47: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
761 | : estimate_ratio_interval<Point>(*(BallSet.end() - 1),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
762 | P, *(ratios.end() - 1),
| ~~~~~~~~~~~~~~~~~~~~~~~
763 | er0, parameters.win_len, 1200,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
764 | prob, rng);
| ~~~~~~~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:295:34: required from here
295 | return generic_volume(ZP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
296 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:630:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
630 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = CDHRWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:295:34: required from here
295 | return generic_volume(ZP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
296 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = CDHRWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:295:34: required from here
295 | return generic_volume(ZP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
296 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = RDHRWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = RDHRWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:62:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
62 | vol = volume_cooling_balls<RDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:295:34: required from here
295 | return generic_volume(ZP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
296 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = RDHRWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = RDHRWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:62:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
62 | vol = volume_cooling_balls<RDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:295:34: required from here
295 | return generic_volume(ZP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
296 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BallWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BallWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:64:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
64 | vol = volume_cooling_balls<BallWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:295:34: required from here
295 | return generic_volume(ZP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
296 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BallWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BallWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:64:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
64 | vol = volume_cooling_balls<BallWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:295:34: required from here
295 | return generic_volume(ZP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
296 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:66:53: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
66 | vol = volume_cooling_balls<BilliardWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:295:34: required from here
295 | return generic_volume(ZP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
296 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:66:53: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
66 | vol = volume_cooling_balls<BilliardWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:295:34: required from here
295 | return generic_volume(ZP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
296 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
In file included from include/cartesian_geom/cartesian_kernel.h:25,
from include/volume/volume_cooling_gaussians.hpp:21:
include/cartesian_geom/point.h: In instantiation of ‘bool point<K>::operator==(point<K>&) const [with K = Cartesian<double>]’:
include/convex_bodies/vpolyintersectvpoly.h:154:22: required from ‘std::pair<typename VPolytope::PointType, typename VPolytope::NT> IntersectionOfVpoly<VPolytope, RNGType>::ComputeInnerBall() [with VPolytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; typename VPolytope::PointType = point<Cartesian<double> >; typename VPolytope::NT = double]’
154 | if (p==(*rvert)) {
| ~^~~~~~~~~~
volume.cpp:40:60: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
40 | std::pair<Point, NT> InnerBall = P.ComputeInnerBall();
| ~~~~~~~~~~~~~~~~~~^~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/cartesian_geom/point.h:157:21: warning: comparison of integer expressions of different signedness: ‘int’ and ‘const unsigned int’ [-Wsign-compare]
157 | for (i=0 ; i<d ; i++) {
| ~^~
In file included from include/random_walks/uniform_billiard_walk.hpp:19:
include/convex_bodies/vpolyintersectvpoly.h: In instantiation of ‘bool IntersectionOfVpoly<VPolytope, RNGType>::get_points_for_rounding(PointList&) [with PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; VPolytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/rounding.hpp:51:39: required from ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = CDHRWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
51 | if (!P.get_points_for_rounding(randPoints))
| ~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~
volume.cpp:43:57: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
43 | round_val = round_polytope<CDHRWalk, MT, VT>(P, InnerBall, 10 + 10 * n, rng).second;
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/vpolyintersectvpoly.h:313:30: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | if (num_of_vertices()>40*dimension()) {
| ~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const ball&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, RNG&) [with Point = point<Cartesian<double> >; ball = Ball<point<Cartesian<double> > >; PolyBall2 = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:761:47: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
761 | : estimate_ratio_interval<Point>(*(BallSet.end() - 1),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
762 | P, *(ratios.end() - 1),
| ~~~~~~~~~~~~~~~~~~~~~~~
763 | er0, parameters.win_len, 1200,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
764 | prob, rng);
| ~~~~~~~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:630:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
630 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = CDHRWalk::Walk<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = CDHRWalk::Walk<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = RDHRWalk::Walk<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = RDHRWalk; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:62:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
62 | vol = volume_cooling_balls<RDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = RDHRWalk::Walk<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = RDHRWalk; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:62:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
62 | vol = volume_cooling_balls<RDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BallWalk::Walk<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BallWalk; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:64:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
64 | vol = volume_cooling_balls<BallWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BallWalk::Walk<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BallWalk; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:64:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
64 | vol = volume_cooling_balls<BallWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:66:53: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
66 | vol = volume_cooling_balls<BilliardWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:66:53: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
66 | vol = volume_cooling_balls<BilliardWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = HPolytope<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/sampling/random_point_generators.hpp:63:23: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = BilliardWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
63 | walk.apply(P, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:60:40: required from ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
60 | RandomPointGenerator::apply(P, p, num_of_samples, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
61 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:45:61: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
45 | round_val = round_polytope<BilliardWalk, MT, VT>(P, InnerBall, 2, rng).second;
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/convex_bodies/hpolytope.h: In instantiation of ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&) const [with Point = point<Cartesian<double> >; typename Point::FT = double]’:
include/random_walks/gaussian_rdhr_walk.hpp:102:57: required from ‘void GaussianRDHRWalk::Walk<Polytope, RandomNumberGenerator>::apply(const BallPolytope&, Point&, const NT&, const unsigned int&, RandomNumberGenerator&) [with BallPolytope = HPolytope<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >; NT = double]’
102 | std::pair <NT, NT> dbpair = P.line_intersect(p, v);
| ~~~~~~~~~~~~~~~~^~~~~~
include/volume/volume_cooling_gaussians.hpp:420:23: required from ‘double volume_cooling_gaussians(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&) [with WalkTypePolicy = GaussianRDHRWalk; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
420 | walk.apply(P, p, *avalsIt, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:54:61: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
54 | vol = volume_cooling_gaussians<GaussianRDHRWalk>(P, rng, e, walk_length);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/hpolytope.h:236:22: warning: unused variable ‘j’ [-Wunused-variable]
236 | unsigned int j;
| ^
include/volume/volume_cooling_balls.hpp: In instantiation of ‘bool get_first_ball(const Polytope&, Ball&, NT&, const NT&, const cooling_ball_parameters<NT>&, RNG&) [with Polytope = HPolytope<point<Cartesian<double> > >; Ball = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:299:25: required from ‘bool get_sequence_of_polytopeballs(Polytope&, std::vector<T>&, std::vector<NT>&, const int&, const NT&, const unsigned int&, const cooling_ball_parameters<NT>&, RNG&) [with RandomPointGenerator = RandomPointGenerator<CDHRWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> > >; PolyBall = BallIntersectPolytope<HPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; ball = Ball<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
299 | if ( !get_first_ball(P, B0, ratio, radius, parameters, rng) )
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:741:12: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
737 | if ( !get_sequence_of_polytopeballs
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
738 | <
| ~
739 | RandomPointGenerator,
| ~~~~~~~~~~~~~~~~~~~~~
740 | PolyBall
| ~~~~~~~~
741 | >(P, BallSet, ratios,
| ~^~~~~~~~~~~~~~~~~~~~
742 | N_times_nu, radius, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
743 | parameters, rng) )
| ~~~~~~~~~~~~~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:180:17: warning: comparison of integer expressions of different signedness: ‘int’ and ‘const unsigned int’ [-Wsign-compare]
180 | while (iter <= max_iterarions) {
| ~~~~~^~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘bool get_next_zonotopeball(std::vector<WeightType>&, const PointList&, const NT&, std::vector<NT>&, const cooling_ball_parameters<NT>&) [with Point = point<Cartesian<double> >; ball = Ball<point<Cartesian<double> > >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; NT = double]’:
include/volume/volume_cooling_balls.hpp:319:39: required from ‘bool get_sequence_of_polytopeballs(Polytope&, std::vector<T>&, std::vector<NT>&, const int&, const NT&, const unsigned int&, const cooling_ball_parameters<NT>&, RNG&) [with RandomPointGenerator = RandomPointGenerator<CDHRWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> > >; PolyBall = BallIntersectPolytope<HPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; ball = Ball<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
319 | if ( !get_next_zonotopeball<Point>(BallSet, randPoints, B0.radius(), ratios,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
320 | parameters) )
| ~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:741:12: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
737 | if ( !get_sequence_of_polytopeballs
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
738 | <
| ~
739 | RandomPointGenerator,
| ~~~~~~~~~~~~~~~~~~~~~
740 | PolyBall
| ~~~~~~~~
741 | >(P, BallSet, ratios,
| ~^~~~~~~~~~~~~~~~~~~~
742 | N_times_nu, radius, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
743 | parameters, rng) )
| ~~~~~~~~~~~~~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:236:17: warning: comparison of integer expressions of different signedness: ‘int’ and ‘const unsigned int’ [-Wsign-compare]
236 | while (iter <= max_iterarions)
| ~~~~~^~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = BallIntersectPolytope<HPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/volume/volume_cooling_balls.hpp:675:19: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<HPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
675 | walk.apply(Pb1, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:66:53: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
66 | vol = volume_cooling_balls<BilliardWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = VPolytope<point<Cartesian<double> > >; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/sampling/random_point_generators.hpp:63:23: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = VPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = BilliardWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
63 | walk.apply(P, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:60:40: required from ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = VPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
60 | RandomPointGenerator::apply(P, p, num_of_samples, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
61 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:45:61: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
45 | round_val = round_polytope<BilliardWalk, MT, VT>(P, InnerBall, 2, rng).second;
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘bool get_first_ball(const Polytope&, Ball&, NT&, const NT&, const cooling_ball_parameters<NT>&, RNG&) [with Polytope = VPolytope<point<Cartesian<double> > >; Ball = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:299:25: required from ‘bool get_sequence_of_polytopeballs(Polytope&, std::vector<T>&, std::vector<NT>&, const int&, const NT&, const unsigned int&, const cooling_ball_parameters<NT>&, RNG&) [with RandomPointGenerator = RandomPointGenerator<CDHRWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> > >; PolyBall = BallIntersectPolytope<VPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; ball = Ball<point<Cartesian<double> > >; Polytope = VPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
299 | if ( !get_first_ball(P, B0, ratio, radius, parameters, rng) )
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:741:12: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
737 | if ( !get_sequence_of_polytopeballs
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
738 | <
| ~
739 | RandomPointGenerator,
| ~~~~~~~~~~~~~~~~~~~~~
740 | PolyBall
| ~~~~~~~~
741 | >(P, BallSet, ratios,
| ~^~~~~~~~~~~~~~~~~~~~
742 | N_times_nu, radius, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
743 | parameters, rng) )
| ~~~~~~~~~~~~~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:180:17: warning: comparison of integer expressions of different signedness: ‘int’ and ‘const unsigned int’ [-Wsign-compare]
180 | while (iter <= max_iterarions) {
| ~~~~~^~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = BallIntersectPolytope<VPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/volume/volume_cooling_balls.hpp:675:19: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<VPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
675 | walk.apply(Pb1, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:66:53: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
66 | vol = volume_cooling_balls<BilliardWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
g++ -std=gnu++17 -I"/data/gannet/ripley/R/R-devel/include" -DNDEBUG -Iexternal -Iexternal/lpsolve/headers/run_headers -Iexternal/minimum_ellipsoid -Iinclude -Iinclude/convex_bodies/spectrahedra -I'/data/gannet/ripley/R/test-dev/Rcpp/include' -I'/data/gannet/ripley/R/test-dev/RcppEigen/include' -I'/data/gannet/ripley/R/test-dev/BH/include' -I/usr/local/include -DBOOST_NO_AUTO_PTR -fpic -g -O2 -Wall -pedantic -mtune=native -Wno-ignored-attributes -Wno-parentheses -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -c zonotope_approximation.cpp -o zonotope_approximation.o
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘static NT compute_diameter<Zonotope<Point> >::compute(const Zonotope<Point>&) [with NT = double; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:220:39: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
219 | _Len = compute_diameter<GenericPolytope>
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
220 | ::template compute<NT>(P);
| ~~~~~~~~~~~~~~~~~~~~~~^~~
include/volume/volume_cooling_balls.hpp:671:14: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
671 | WalkType walk(Pb1, p, rng);
| ^~~~
include/volume/volume_cooling_hpoly.hpp:341:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
341 | vol = vol / estimate_ratio_interval<WalkType, Point>(P, HP, ratios[0], er1, parameters.win_len, N_times_nu,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
342 | prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:292:73: required from here
292 | return volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:84:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
84 | for (int i = 0; i < P.dimension(); ++i) {
| ~~^~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:221:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
221 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:671:14: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
671 | WalkType walk(Pb1, p, rng);
| ^~~~
include/volume/volume_cooling_hpoly.hpp:341:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
341 | vol = vol / estimate_ratio_interval<WalkType, Point>(P, HP, ratios[0], er1, parameters.win_len, N_times_nu,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
342 | prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:292:73: required from here
292 | return volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:221:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
221 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:671:14: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
671 | WalkType walk(Pb1, p, rng);
| ^~~~
include/volume/volume_cooling_hpoly.hpp:363:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
363 | vol = vol / estimate_ratio_interval<WalkType, Point>(zb1, b2, ratios[i], er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
364 | N_times_nu, prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:292:73: required from here
292 | return volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘bool get_first_ball(const Polytope&, Ball&, NT&, const NT&, const cooling_ball_parameters<NT>&, RNG&) [with Polytope = Zonotope<point<Cartesian<double> > >; Ball = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:299:25: required from ‘bool get_sequence_of_polytopeballs(Polytope&, std::vector<T>&, std::vector<NT>&, const int&, const NT&, const unsigned int&, const cooling_ball_parameters<NT>&, RNG&) [with RandomPointGenerator = RandomPointGenerator<CDHRWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> > >; PolyBall = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; ball = Ball<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
299 | if ( !get_first_ball(P, B0, ratio, radius, parameters, rng) )
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:741:12: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
737 | if ( !get_sequence_of_polytopeballs
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
738 | <
| ~
739 | RandomPointGenerator,
| ~~~~~~~~~~~~~~~~~~~~~
740 | PolyBall
| ~~~~~~~~
741 | >(P, BallSet, ratios,
| ~^~~~~~~~~~~~~~~~~~~~
742 | N_times_nu, radius, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
743 | parameters, rng) )
| ~~~~~~~~~~~~~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:295:34: required from here
295 | return generic_volume(ZP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
296 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:180:17: warning: comparison of integer expressions of different signedness: ‘int’ and ‘const unsigned int’ [-Wsign-compare]
180 | while (iter <= max_iterarions) {
| ~~~~~^~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/volume/volume_cooling_balls.hpp:675:19: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
675 | walk.apply(Pb1, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:66:53: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
66 | vol = volume_cooling_balls<BilliardWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:295:34: required from here
295 | return generic_volume(ZP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
296 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/sampling/random_point_generators.hpp:63:23: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = BilliardWalk::Walk<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
63 | walk.apply(P, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:60:40: required from ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
60 | RandomPointGenerator::apply(P, p, num_of_samples, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
61 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:45:61: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
45 | round_val = round_polytope<BilliardWalk, MT, VT>(P, InnerBall, 2, rng).second;
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘bool get_first_ball(const Polytope&, Ball&, NT&, const NT&, const cooling_ball_parameters<NT>&, RNG&) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Ball = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:299:25: required from ‘bool get_sequence_of_polytopeballs(Polytope&, std::vector<T>&, std::vector<NT>&, const int&, const NT&, const unsigned int&, const cooling_ball_parameters<NT>&, RNG&) [with RandomPointGenerator = RandomPointGenerator<CDHRWalk::Walk<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> > >; PolyBall = BallIntersectPolytope<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, Ball<point<Cartesian<double> > > >; ball = Ball<point<Cartesian<double> > >; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
299 | if ( !get_first_ball(P, B0, ratio, radius, parameters, rng) )
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:741:12: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
737 | if ( !get_sequence_of_polytopeballs
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
738 | <
| ~
739 | RandomPointGenerator,
| ~~~~~~~~~~~~~~~~~~~~~
740 | PolyBall
| ~~~~~~~~
741 | >(P, BallSet, ratios,
| ~^~~~~~~~~~~~~~~~~~~~
742 | N_times_nu, radius, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
743 | parameters, rng) )
| ~~~~~~~~~~~~~~~~
volume.cpp:60:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
60 | vol = volume_cooling_balls<CDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:180:17: warning: comparison of integer expressions of different signedness: ‘int’ and ‘const unsigned int’ [-Wsign-compare]
180 | while (iter <= max_iterarions) {
| ~~~~~^~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = BallIntersectPolytope<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, Ball<point<Cartesian<double> > > >; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/volume/volume_cooling_balls.hpp:675:19: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
675 | walk.apply(Pb1, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:66:53: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
66 | vol = volume_cooling_balls<BilliardWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = HPolytope<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:221:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = HPolytope<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
221 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/sampling/random_point_generators.hpp:60:14: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = BilliardWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
60 | Walk walk(P, p, rng);
| ^~~~
include/volume/rounding.hpp:60:40: required from ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
60 | RandomPointGenerator::apply(P, p, num_of_samples, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
61 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:45:61: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
45 | round_val = round_polytope<BilliardWalk, MT, VT>(P, InnerBall, 2, rng).second;
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
include/convex_bodies/hpolytope.h: In instantiation of ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&, VT&, VT&, const NT&, bool) const [with Point = point<Cartesian<double> >; typename Point::FT = double; VT = Eigen::Matrix<double, -1, 1>; NT = double]’:
include/random_walks/uniform_rdhr_walk.hpp:64:55: required from ‘void RDHRWalk::Walk<Polytope, RandomNumberGenerator>::apply(const BallPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with BallPolytope = HPolytope<point<Cartesian<double> > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
64 | std::pair<NT, NT> bpair = P.line_intersect(_p, v, _lamdas, _Av,
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
65 | _lambda);
| ~~~~~~~~
include/volume/volume_cooling_balls.hpp:675:19: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = RDHRWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = HPolytope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
675 | walk.apply(Pb1, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = RDHRWalk; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
volume.cpp:62:49: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
62 | vol = volume_cooling_balls<RDHRWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/hpolytope.h:313:12: warning: unused variable ‘mult’ [-Wunused-variable]
313 | NT mult;
| ^~~~
include/convex_bodies/hpolytope.h:315:22: warning: unused variable ‘j’ [-Wunused-variable]
315 | unsigned int j;
| ^
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = BallIntersectPolytope<HPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:221:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = BallIntersectPolytope<HPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
221 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:671:14: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<HPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
671 | WalkType walk(Pb1, p, rng);
| ^~~~
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = HPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:66:53: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = HPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
66 | vol = volume_cooling_balls<BilliardWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:261:34: required from here
261 | return generic_volume(HP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
262 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = VPolytope<point<Cartesian<double> > >; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:221:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = VPolytope<point<Cartesian<double> > >; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
221 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/sampling/random_point_generators.hpp:60:14: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = VPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = BilliardWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
60 | Walk walk(P, p, rng);
| ^~~~
include/volume/rounding.hpp:60:40: required from ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = VPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
60 | RandomPointGenerator::apply(P, p, num_of_samples, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
61 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:45:61: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
45 | round_val = round_polytope<BilliardWalk, MT, VT>(P, InnerBall, 2, rng).second;
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
write_sdpa_format_file.cpp: In function ‘void write_sdpa_format_file(Rcpp::Reference, Rcpp::NumericVector, std::string)’:
write_sdpa_format_file.cpp:52:28: warning: typedef ‘RNGType’ locally defined but not used [-Wunused-local-typedefs]
52 | typedef boost::mt19937 RNGType;
| ^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = BallIntersectPolytope<VPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:221:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = BallIntersectPolytope<VPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
221 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:671:14: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<VPolytope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
671 | WalkType walk(Pb1, p, rng);
| ^~~~
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = VPolytope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:66:53: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = VPolytope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
66 | vol = volume_cooling_balls<BilliardWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:268:34: required from here
268 | return generic_volume(VP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
269 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
In file included from include/convex_bodies/zpolytope.h:19,
from include/random_walks/uniform_billiard_walk.hpp:20:
include/lp_oracles/zpolyoracles.h: In instantiation of ‘bool memLP_Zonotope(const MT&, const Point&, NT*, int*) [with MT = Eigen::Matrix<double, -1, -1>; Point = point<Cartesian<double> >; NT = double]’:
include/convex_bodies/zpolytope.h:241:26: required from ‘int Zonotope<Point>::is_in(const Point&) const [with Point = point<Cartesian<double> >]’
241 | if(memLP_Zonotope(V, p, row_mem, colno_mem))
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:79:20: required from ‘bool check_convergence(const ConvexBody&, const PointList&, bool&, NT&, const int&, const bool&, const bool&, const cooling_ball_parameters<NT>&) [with Point = point<Cartesian<double> >; ConvexBody = Zonotope<point<Cartesian<double> > >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; NT = double]’
79 | if (P.is_in(*pit)==-1) countsIn++;
| ~~~~~~~^~~~~~
include/volume/volume_cooling_hpoly.hpp:66:36: required from ‘bool get_first_poly(Zonotope&, HPolytope&, NT&, const cooling_ball_parameters<NT>&, RNG&, VT&) [with RandomPointGenerator = RandomPointGenerator<CDHRWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; HPolytope = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; VT = Eigen::Matrix<double, -1, 1>]’
66 | if(check_convergence<Point>(P, randPoints,
| ~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~
67 | too_few, ratio, parameters.nu,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
68 | true, false, parameters)){
| ~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:297:51: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = CDHRWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
297 | if ( !get_first_poly<CdhrRandomPointGenerator>(P, HP, ratio, parameters, rng, b_max) )
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:286:69: required from here
286 | return volume_cooling_hpoly<CDHRWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/lp_oracles/zpolyoracles.h:52:10: warning: unused variable ‘infinite’ [-Wunused-variable]
52 | REAL infinite = get_infinite(lp); /* will return 1.0e30 */
| ^~~~~~~~
include/lp_oracles/zpolyoracles.h: In instantiation of ‘std::pair<_FIter, _FIter> intersect_line_zono(const MT&, const Point&, const Point&, NT*, int*) [with NT = double; MT = Eigen::Matrix<double, -1, -1>; Point = point<Cartesian<double> >]’:
include/convex_bodies/zpolytope.h:296:35: required from ‘std::pair<typename Point::FT, typename Point::FT> Zonotope<Point>::line_intersect(const Point&, const Point&, const VT&, const VT&, const NT&) const [with Point = point<Cartesian<double> >; typename Point::FT = double; VT = Eigen::Matrix<double, -1, 1>; NT = double]’
296 | return intersect_line_zono(V, r, v, conv_comb, colno);
| ~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_rdhr_walk.hpp:64:55: required from ‘void RDHRWalk::Walk<Polytope, RandomNumberGenerator>::apply(const BallPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with BallPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
64 | std::pair<NT, NT> bpair = P.line_intersect(_p, v, _lamdas, _Av,
| ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
65 | _lambda);
| ~~~~~~~~
include/volume/volume_cooling_balls.hpp:675:19: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = RDHRWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
675 | walk.apply(Pb1, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:341:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = RDHRWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
341 | vol = vol / estimate_ratio_interval<WalkType, Point>(P, HP, ratios[0], er1, parameters.win_len, N_times_nu,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
342 | prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:288:69: required from here
288 | return volume_cooling_hpoly<RDHRWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/lp_oracles/zpolyoracles.h:140:8: warning: unused variable ‘res’ [-Wunused-variable]
140 | NT res;
| ^~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:221:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
221 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:671:14: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
671 | WalkType walk(Pb1, p, rng);
| ^~~~
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:66:53: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = Zonotope<point<Cartesian<double> > >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
66 | vol = volume_cooling_balls<BilliardWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:295:34: required from here
295 | return generic_volume(ZP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
296 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:221:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
221 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/sampling/random_point_generators.hpp:60:14: required from ‘static void RandomPointGenerator<Walk>::apply(Polytope&, Point&, const unsigned int&, const unsigned int&, PointList&, WalkPolicy&, RandomNumberGenerator&) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; WalkPolicy = PushBackWalkPolicy; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Walk = BilliardWalk::Walk<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >]’
60 | Walk walk(P, p, rng);
| ^~~~
include/volume/rounding.hpp:60:40: required from ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = BilliardWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
60 | RandomPointGenerator::apply(P, p, num_of_samples, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
61 | randPoints, push_back_policy, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:45:61: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
45 | round_val = round_polytope<BilliardWalk, MT, VT>(P, InnerBall, 2, rng).second;
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = BallIntersectPolytope<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, Ball<point<Cartesian<double> > > >; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:221:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = BallIntersectPolytope<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, Ball<point<Cartesian<double> > > >; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
221 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:671:14: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
671 | WalkType walk(Pb1, p, rng);
| ^~~~
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
volume.cpp:66:53: required from ‘double generic_volume(Polytope&, RNGType&, unsigned int, NT, bool, bool, unsigned int, bool, bool, bool, bool, bool, int) [with Polytope = IntersectionOfVpoly<VPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; RNGType = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; NT = double]’
66 | vol = volume_cooling_balls<BilliardWalk>(P, rng, e, walk_length, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
volume.cpp:313:34: required from here
313 | return generic_volume(VPcVP, rng, walkL, e, CG, CB, win_len, rounding,
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
314 | cdhr, rdhr, ball_walk, billiard, type_num);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
In file included from write_sdpa_format_file.cpp:18:
include/convex_bodies/spectrahedra/LMI.h: In instantiation of ‘void LMI<NT, Eigen::Matrix<Type, -1, -1>, Eigen::Matrix<Type, -1, 1> >::setVectorMatrix() [with NT = double]’:
include/convex_bodies/spectrahedra/LMI.h:61:9: required from ‘LMI<NT, Eigen::Matrix<Type, -1, -1>, Eigen::Matrix<Type, -1, 1> >::LMI(const std::vector<Eigen::Matrix<Type, -1, -1> >&) [with NT = double]’
61 | setVectorMatrix();
| ^~~~~~~~~~~~~~~
write_sdpa_format_file.cpp:57:21: required from here
57 | LMI lmi(matrices);
| ^
include/convex_bodies/spectrahedra/LMI.h:82:41: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
82 | for (int at_row = 0; at_row < m; at_row++)
| ~~~~~~~^~~
include/convex_bodies/spectrahedra/LMI.h:83:50: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
83 | for (int at_col = at_row; at_col < m; at_col++) {
| ~~~~~~~^~~
In file included from write_sdpa_format_file.cpp:20:
include/SDPAFormatManager.h: In instantiation of ‘void SdpaFormatManager<NT>::writeSDPAFormatFile(std::ostream&, const std::vector<Eigen::Matrix<Type, -1, -1> >&, const VT&) [with NT = double; std::ostream = std::basic_ostream<char>; VT = Eigen::Matrix<double, -1, 1>]’:
include/SDPAFormatManager.h:264:28: required from ‘void SdpaFormatManager<NT>::writeSDPAFormatFile(std::ostream&, const Spectrahedron<NT, Eigen::Matrix<Type, -1, -1>, Eigen::Matrix<Type, -1, 1> >&, const Point&) [with Point = point<Cartesian<double> >; NT = double; std::ostream = std::basic_ostream<char>]’
264 | writeSDPAFormatFile(os, spectrahedron.getLMI().getMatrices(), objectiveFunction.getCoefficients());
| ~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
write_sdpa_format_file.cpp:66:42: required from here
66 | sdpaFormatManager.writeSDPAFormatFile(os, _spectrahedron, c);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~
include/SDPAFormatManager.h:235:27: warning: comparison of integer expressions of different signedness: ‘int’ and ‘std::vector<Eigen::Matrix<double, -1, -1> >::size_type’ {aka ‘long unsigned int’} [-Wsign-compare]
235 | for (int at=1 ; at<matrices.size() ; ++at)
| ~~^~~~~~~~~~~~~~~~
make[2]: Entering directory '/data/gannet/ripley/R/packages/tests-devel/volesti/src/external/lpsolve/build/lp_solve'
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c colamd.c -o colamd.o
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_MDO.c -o lp_MDO.o
In file included from lp_MDO.c:22:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_mipbb.c -o lp_mipbb.o
In file included from lp_mipbb.c:30:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_rlp.c -o lp_rlp.o
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c mmio.c -o mmio.o
In file included from zonotope_approximation.cpp:16:
include/volume/volume_cooling_gaussians.hpp: In function ‘NT get_next_gaussian(const Polytope&, Point&, const NT&, const unsigned int&, const NT&, const NT&, const unsigned int&, RandomNumberGenerator&)’:
include/volume/volume_cooling_gaussians.hpp:166:48: warning: typedef ‘viterator’ locally defined but not used [-Wunused-local-typedefs]
166 | typedef typename std::vector<NT>::iterator viterator;
| ^~~~~~~~~
include/volume/volume_cooling_gaussians.hpp: In function ‘void compute_annealing_schedule(const Polytope&, const NT&, const NT&, const NT&, const unsigned int&, const unsigned int&, const NT&, const NT&, std::vector<NT>&, RandomNumberGenerator&)’:
include/volume/volume_cooling_gaussians.hpp:221:35: warning: typedef ‘VT’ locally defined but not used [-Wunused-local-typedefs]
221 | typedef typename Polytope::VT VT;
| ^~
mmio.c: In function ‘mm_read_unsymmetric_sparse’:
mmio.c:26:9: warning: variable ‘x’ set but not used [-Wunused-but-set-variable]
26 | int x;
| ^
mmio.c: In function ‘mm_typecode_to_str’:
mmio.c:402:11: warning: variable ‘types’ set but not used [-Wunused-but-set-variable]
402 | char *types[4];
| ^~~~~
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c commonlib.c -o commonlib.o
In file included from commonlib.c:29:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
commonlib.c: In function ‘printvec’:
commonlib.c:878:7: warning: unused variable ‘i’ [-Wunused-variable]
878 | int i;
| ^
In file included from zonotope_approximation.cpp:17:
include/volume/volume_cooling_balls.hpp: In function ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&)’:
include/volume/volume_cooling_balls.hpp:707:35: warning: typedef ‘VT’ locally defined but not used [-Wunused-local-typedefs]
707 | typedef typename Polytope::VT VT;
| ^~
include/volume/volume_cooling_balls.hpp:708:31: warning: typedef ‘PointList’ locally defined but not used [-Wunused-local-typedefs]
708 | typedef std::list <Point> PointList;
| ^~~~~~~~~
In file included from zonotope_approximation.cpp:18:
include/volume/volume_cooling_hpoly.hpp: In function ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&)’:
include/volume/volume_cooling_hpoly.hpp:269:31: warning: typedef ‘PointList’ locally defined but not used [-Wunused-local-typedefs]
269 | typedef std::list <Point> PointList;
| ^~~~~~~~~
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_MPS.c -o lp_MPS.o
In file included from lp_MPS.c:5:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
lp_MPS.c: In function ‘number’:
lp_MPS.c:1203:9: warning: unused variable ‘n’ [-Wunused-variable]
1203 | int n=13;
| ^
lp_MPS.c:1243:9: warning: unused variable ‘n’ [-Wunused-variable]
1243 | int n=13;
| ^
include/volume/volume_cooling_hpoly.hpp: In instantiation of ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
zonotope_approximation.cpp:105:64: required from here
105 | vol = volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:359:27: warning: comparison of integer expressions of different signedness: ‘int’ and ‘std::vector<HPolytope<point<Cartesian<double> > >, std::allocator<HPolytope<point<Cartesian<double> > > > >::size_type’ {aka ‘long unsigned int’} [-Wsign-compare]
359 | for (int i = 0; i < HPolySet.size()-1; ++i) {
| ~~^~~~~~~~~~~~~~~~~~~
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_params.c -o lp_params.o
In file included from lp_params.c:15:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
lp_params.c: In function ‘write_params1’:
lp_params.c:321:11: warning: variable ‘a’ set but not used [-Wunused-but-set-variable]
321 | LPSREAL a = 0;
| ^
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const ball&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, RNG&) [with Point = point<Cartesian<double> >; ball = Ball<point<Cartesian<double> > >; PolyBall2 = Zonotope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:761:47: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
761 | : estimate_ratio_interval<Point>(*(BallSet.end() - 1),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
762 | P, *(ratios.end() - 1),
| ~~~~~~~~~~~~~~~~~~~~~~~
763 | er0, parameters.win_len, 1200,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
764 | prob, rng);
| ~~~~~~~~~~
zonotope_approximation.cpp:103:53: required from here
103 | vol = volume_cooling_balls<BilliardWalk>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:630:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
630 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
zonotope_approximation.cpp:103:53: required from here
103 | vol = volume_cooling_balls<BilliardWalk>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
zonotope_approximation.cpp:103:53: required from here
103 | vol = volume_cooling_balls<BilliardWalk>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp: In instantiation of ‘bool get_first_poly(Zonotope&, HPolytope&, NT&, const cooling_ball_parameters<NT>&, RNG&, VT&) [with RandomPointGenerator = RandomPointGenerator<CDHRWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; HPolytope = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; VT = Eigen::Matrix<double, -1, 1>]’:
include/volume/volume_cooling_hpoly.hpp:297:51: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
297 | if ( !get_first_poly<CdhrRandomPointGenerator>(P, HP, ratio, parameters, rng, b_max) )
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
zonotope_approximation.cpp:105:64: required from here
105 | vol = volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:53:16: warning: comparison of integer expressions of different signedness: ‘int’ and ‘const unsigned int’ [-Wsign-compare]
53 | while(iter <= max_iterarions) {
| ~~~~~^~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:45:46: warning: unused variable ‘N’ [-Wunused-variable]
45 | int n = P.dimension(), m = b_max.size(), N = 1200, iter = 1, count = 0;
| ^
include/volume/volume_cooling_hpoly.hpp:45:66: warning: unused variable ‘count’ [-Wunused-variable]
45 | int n = P.dimension(), m = b_max.size(), N = 1200, iter = 1, count = 0;
| ^~~~~
include/volume/volume_cooling_hpoly.hpp:47:19: warning: unused variable ‘print’ [-Wunused-variable]
47 | bool too_few, print = false;
| ^~~~~
In file included from include/volume/volume_sequence_of_balls.hpp:33,
from zonotope_approximation.cpp:15:
include/volume/rounding.hpp: In instantiation of ‘std::pair<std::pair<_Tp1, _Tp2>, NT> round_polytope(Polytope&, std::pair<Point, NT>&, const unsigned int&, RandomNumberGenerator&) [with WalkTypePolicy = CDHRWalk; MT = Eigen::Matrix<double, -1, -1>; VT = Eigen::Matrix<double, -1, 1>; Polytope = HPolytope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_hpoly.hpp:325:78: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
325 | std::pair< std::pair<MT, VT>, NT > res = round_polytope<CDHRWalk, MT, VT>(HP2, InnerBall,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~
326 | 10 + 10 * n, rng);
| ~~~~~~~~~~~~~~~~~
zonotope_approximation.cpp:105:64: required from here
105 | vol = volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/rounding.hpp:70:25: warning: comparison of integer expressions of different signedness: ‘unsigned int’ and ‘int’ [-Wsign-compare]
70 | for (i=0 ; i<rpit->dimension(); i++){
| ~^~~~~~~~~~~~~~~~~~
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_scale.c -o lp_scale.o
In file included from lp_scale.c:3:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = CDHRWalk::Walk<HPolytope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = HPolytope<point<Cartesian<double> > >; PolyBall2 = Zonotope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_hpoly.hpp:332:56: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
332 | vol *= estimate_ratio_interval<CdhrWalk, Point>(HP, P, ratio, er0, parameters.win_len, 1200, prob, 10+10*n, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
zonotope_approximation.cpp:105:64: required from here
105 | vol = volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_hpoly.hpp:341:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
341 | vol = vol / estimate_ratio_interval<WalkType, Point>(P, HP, ratios[0], er1, parameters.win_len, N_times_nu,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
342 | prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~
zonotope_approximation.cpp:105:64: required from here
105 | vol = volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_hpoly.hpp:363:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
363 | vol = vol / estimate_ratio_interval<WalkType, Point>(zb1, b2, ratios[i], er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
364 | N_times_nu, prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
zonotope_approximation.cpp:105:64: required from here
105 | vol = volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:673:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
673 | for (int i = 0; i < ratio_parameters.W; ++i)
| ~~^~~~~~~~~~~~~~~~~~~~
lp_scale.c: In function ‘CurtisReidScales’:
lp_scale.c:150:24: warning: variable ‘ekm2’ set but not used [-Wunused-but-set-variable]
150 | qkm2, qkqkm1, ekm2, ekekm1,
| ^~~~
lp_scale.c:150:10: warning: variable ‘qkm2’ set but not used [-Wunused-but-set-variable]
150 | qkm2, qkqkm1, ekm2, ekekm1,
| ^~~~
lp_scale.c: In function ‘scale_columns’:
lp_scale.c:632:16: warning: variable ‘colMax’ set but not used [-Wunused-but-set-variable]
632 | int i,j, colMax, nz;
| ^~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘bool get_first_ball(const Polytope&, Ball&, NT&, const NT&, const cooling_ball_parameters<NT>&, RNG&) [with Polytope = Zonotope<point<Cartesian<double> > >; Ball = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’:
include/volume/volume_cooling_balls.hpp:299:25: required from ‘bool get_sequence_of_polytopeballs(Polytope&, std::vector<T>&, std::vector<NT>&, const int&, const NT&, const unsigned int&, const cooling_ball_parameters<NT>&, RNG&) [with RandomPointGenerator = RandomPointGenerator<BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> > >; PolyBall = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; ball = Ball<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
299 | if ( !get_first_ball(P, B0, ratio, radius, parameters, rng) )
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:741:12: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
737 | if ( !get_sequence_of_polytopeballs
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
738 | <
| ~
739 | RandomPointGenerator,
| ~~~~~~~~~~~~~~~~~~~~~
740 | PolyBall
| ~~~~~~~~
741 | >(P, BallSet, ratios,
| ~^~~~~~~~~~~~~~~~~~~~
742 | N_times_nu, radius, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
743 | parameters, rng) )
| ~~~~~~~~~~~~~~~~
zonotope_approximation.cpp:103:53: required from here
103 | vol = volume_cooling_balls<BilliardWalk>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:180:17: warning: comparison of integer expressions of different signedness: ‘int’ and ‘const unsigned int’ [-Wsign-compare]
180 | while (iter <= max_iterarions) {
| ~~~~~^~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp: In instantiation of ‘bool get_next_zonotopeball(std::vector<WeightType>&, const PointList&, const NT&, std::vector<NT>&, const cooling_ball_parameters<NT>&) [with Point = point<Cartesian<double> >; ball = Ball<point<Cartesian<double> > >; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; NT = double]’:
include/volume/volume_cooling_balls.hpp:319:39: required from ‘bool get_sequence_of_polytopeballs(Polytope&, std::vector<T>&, std::vector<NT>&, const int&, const NT&, const unsigned int&, const cooling_ball_parameters<NT>&, RNG&) [with RandomPointGenerator = RandomPointGenerator<BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> > >; PolyBall = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; ball = Ball<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
319 | if ( !get_next_zonotopeball<Point>(BallSet, randPoints, B0.radius(), ratios,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
320 | parameters) )
| ~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:741:12: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
737 | if ( !get_sequence_of_polytopeballs
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
738 | <
| ~
739 | RandomPointGenerator,
| ~~~~~~~~~~~~~~~~~~~~~
740 | PolyBall
| ~~~~~~~~
741 | >(P, BallSet, ratios,
| ~^~~~~~~~~~~~~~~~~~~~
742 | N_times_nu, radius, walk_length,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
743 | parameters, rng) )
| ~~~~~~~~~~~~~~~~
zonotope_approximation.cpp:103:53: required from here
103 | vol = volume_cooling_balls<BilliardWalk>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:236:17: warning: comparison of integer expressions of different signedness: ‘int’ and ‘const unsigned int’ [-Wsign-compare]
236 | while (iter <= max_iterarions)
| ~~~~~^~~~~~~~~~~~~~~~~
In file included from include/random_walks/random_walks.hpp:16,
from zonotope_approximation.cpp:14:
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/volume/volume_cooling_balls.hpp:675:19: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
675 | walk.apply(Pb1, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
zonotope_approximation.cpp:103:53: required from here
103 | vol = volume_cooling_balls<BilliardWalk>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/volume/volume_cooling_balls.hpp:675:19: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
675 | walk.apply(Pb1, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
zonotope_approximation.cpp:103:53: required from here
103 | vol = volume_cooling_balls<BilliardWalk>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/volume/volume_cooling_hpoly.hpp: In instantiation of ‘bool get_next_zonoball(std::vector<WeightType>&, HPolytope&, const VT&, const VT&, PointList&, std::vector<NT>&, const cooling_ball_parameters<NT>&) [with Zonotope = Zonotope<point<Cartesian<double> > >; HPolytope = HPolytope<point<Cartesian<double> > >; VT = Eigen::Matrix<double, -1, 1>; PointList = std::__cxx11::list<point<Cartesian<double> >, std::allocator<point<Cartesian<double> > > >; NT = double]’:
include/volume/volume_cooling_hpoly.hpp:181:38: required from ‘bool get_sequence_of_zonopolys(Zonotope&, const HPolytope&, std::vector<NT>&, std::vector<NT>&, const VT&, const unsigned int&, const unsigned int&, const cooling_ball_parameters<NT>&, RNG&) [with RandomPointGenerator = RandomPointGenerator<BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> > >; ZonoHP = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; Zonotope = Zonotope<point<Cartesian<double> > >; HPolytope = HPolytope<point<Cartesian<double> > >; VT = Eigen::Matrix<double, -1, 1>; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
181 | if ( !get_next_zonoball<Zonotope>(HPolySet, HP2, b_max, HP.get_vec(),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
182 | randPoints, ratios, parameters))
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:309:24: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
308 | if ( !get_sequence_of_zonopolys<ZonoRandomPointGenerator, ZonoHP>
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
309 | (P, HP, HPolySet, ratios,
| ^~~~~~~~~~~~~~~~~~~~~~~~~
310 | b_max, N_times_nu, walk_length, parameters, rng) )
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
zonotope_approximation.cpp:105:64: required from here
105 | vol = volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:113:17: warning: comparison of integer expressions of different signedness: ‘int’ and ‘const unsigned int’ [-Wsign-compare]
113 | while (iter <= max_iterarions) {
| ~~~~~^~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:108:9: warning: unused variable ‘n’ [-Wunused-variable]
108 | int n = HP2.dimension(), iter = 1;
| ^
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/volume/volume_cooling_balls.hpp:675:19: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
675 | walk.apply(Pb1, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:363:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
363 | vol = vol / estimate_ratio_interval<WalkType, Point>(zb1, b2, ratios[i], er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
364 | N_times_nu, prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
zonotope_approximation.cpp:105:64: required from here
105 | vol = volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:253:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
253 | while (it < 50*n)
| ~~~^~~~~~
include/random_walks/uniform_billiard_walk.hpp:268:20: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
268 | if (it == 50*n){
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘static NT compute_diameter<Zonotope<Point> >::compute(const Zonotope<Point>&) [with NT = double; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:220:39: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
219 | _Len = compute_diameter<GenericPolytope>
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
220 | ::template compute<NT>(P);
| ~~~~~~~~~~~~~~~~~~~~~~^~~
include/volume/volume_cooling_balls.hpp:671:14: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
671 | WalkType walk(Pb1, p, rng);
| ^~~~
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
zonotope_approximation.cpp:103:53: required from here
103 | vol = volume_cooling_balls<BilliardWalk>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:84:23: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
84 | for (int i = 0; i < P.dimension(); ++i) {
| ~~^~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:221:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = Zonotope<point<Cartesian<double> > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
221 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:671:14: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = Zonotope<point<Cartesian<double> > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
671 | WalkType walk(Pb1, p, rng);
| ^~~~
include/volume/volume_cooling_balls.hpp:776:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
775 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
776 | <WalkType, Point>(P,
| ~~~~~~~~~~~~~~~~~^~~
777 | *balliter,
| ~~~~~~~~~~
778 | *ratioiter,
| ~~~~~~~~~~~
779 | er1,
| ~~~~
780 | parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~
781 | N_times_nu,
| ~~~~~~~~~~~
782 | prob,
| ~~~~~
783 | walk_length,
| ~~~~~~~~~~~~
784 | rng)
| ~~~~
zonotope_approximation.cpp:103:53: required from here
103 | vol = volume_cooling_balls<BilliardWalk>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:221:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
221 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:671:14: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = BallIntersectPolytope<Zonotope<point<Cartesian<double> > >, Ball<point<Cartesian<double> > > >; PolyBall2 = Ball<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
671 | WalkType walk(Pb1, p, rng);
| ^~~~
include/volume/volume_cooling_balls.hpp:800:50: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
799 | 1 / estimate_ratio_interval
| ~~~~~~~~~~~~~~~~~~~~~~~
800 | <WalkType, Point>(Pb,
| ~~~~~~~~~~~~~~~~~^~~~
801 | *(balliter + 1),
| ~~~~~~~~~~~~~~~~
802 | *(ratioiter + 1),
| ~~~~~~~~~~~~~~~~~
803 | er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~
804 | N_times_nu,
| ~~~~~~~~~~~
805 | prob, walk_length,
| ~~~~~~~~~~~~~~~~~~
806 | rng)
| ~~~~
zonotope_approximation.cpp:103:53: required from here
103 | vol = volume_cooling_balls<BilliardWalk>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp: In instantiation of ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::initialize(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’:
include/random_walks/uniform_billiard_walk.hpp:221:19: required from ‘BilliardWalk::Walk<Polytope, RandomNumberGenerator>::Walk(const GenericPolytope&, const Point&, RandomNumberGenerator&) [with GenericPolytope = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
221 | initialize(P, p, rng);
| ~~~~~~~~~~^~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:671:14: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
671 | WalkType walk(Pb1, p, rng);
| ^~~~
include/volume/volume_cooling_hpoly.hpp:363:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
363 | vol = vol / estimate_ratio_interval<WalkType, Point>(zb1, b2, ratios[i], er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
364 | N_times_nu, prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
zonotope_approximation.cpp:105:64: required from here
105 | vol = volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:313:19: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
313 | while (it <= 50*n)
| ~~~^~~~~~~
include/random_walks/uniform_billiard_walk.hpp:321:26: warning: comparison of integer expressions of different signedness: ‘int’ and ‘unsigned int’ [-Wsign-compare]
321 | }else if (it == 50*n) {
| ~~~^~~~~~~
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_SOS.c -o lp_SOS.o
In file included from lp_SOS.c:3:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
In file included from include/convex_bodies/zpolytope.h:19,
from include/random_walks/uniform_billiard_walk.hpp:20:
include/lp_oracles/zpolyoracles.h: In instantiation of ‘bool memLP_Zonotope(const MT&, const Point&, NT*, int*) [with MT = Eigen::Matrix<double, -1, -1>; Point = point<Cartesian<double> >; NT = double]’:
include/convex_bodies/zpolytope.h:241:26: required from ‘int Zonotope<Point>::is_in(const Point&) const [with Point = point<Cartesian<double> >]’
241 | if(memLP_Zonotope(V, p, row_mem, colno_mem))
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:400:22: required from ‘bool estimate_ratio_generic(const Pollyball&, const Point&, const NT&, estimate_ratio_parameters<NT>&) [with Pollyball = Zonotope<point<Cartesian<double> > >; Point = point<Cartesian<double> >; NT = double]’
400 | if (Pb2.is_in(p) == -1) ratio_parameters.count_in = ratio_parameters.count_in + 1.0;
| ~~~~~~~~~^~~
include/volume/volume_cooling_balls.hpp:496:36: required from ‘NT estimate_ratio(const ball&, const PolyBall&, const NT&, const NT&, const int&, const int&, RNG&) [with Point = point<Cartesian<double> >; ball = Ball<point<Cartesian<double> > >; PolyBall = Zonotope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
496 | } while(!estimate_ratio_generic(Pb2, p, error, ratio_parameters));
| ~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:758:38: required from ‘double volume_cooling_balls(const Polytope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
758 | estimate_ratio<Point>(*(BallSet.end() - 1),
| ~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~
759 | P, *(ratios.end() - 1),
| ~~~~~~~~~~~~~~~~~~~~~~~
760 | er0, parameters.win_len, 1200, rng)
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
zonotope_approximation.cpp:103:53: required from here
103 | vol = volume_cooling_balls<BilliardWalk>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/lp_oracles/zpolyoracles.h:52:10: warning: unused variable ‘infinite’ [-Wunused-variable]
52 | REAL infinite = get_infinite(lp); /* will return 1.0e30 */
| ^~~~~~~~
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_presolve.c -o lp_presolve.o
In file included from lp_presolve.c:36:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
lp_presolve.c: In function ‘presolve_debugmap’:
lp_presolve.c:466:51: warning: variable ‘n’ set but not used [-Wunused-but-set-variable]
466 | int colnr, ix, ie, nx, jx, je, *cols, *rows, n;
| ^
lp_presolve.c: In function ‘presolve_colfixdual’:
lp_presolve.c:1997:18: warning: variable ‘isMI’ set but not used [-Wunused-but-set-variable]
1997 | MYBOOL hasOF, isMI, isDualFREE = TRUE;
| ^~~~
lp_presolve.c: In function ‘presolve_columns’:
lp_presolve.c:4842:46: warning: variable ‘item’ set but not used [-Wunused-but-set-variable]
4842 | status = RUNNING, ix, j, countNZ, item;
| ^~~~
lp_presolve.c:4835:31: warning: variable ‘unbounded’ set but not used [-Wunused-but-set-variable]
4835 | MYBOOL candelete, isOFNZ, unbounded,
| ^~~~~~~~~
lp_presolve.c: In function ‘presolve_rows’:
lp_presolve.c:5280:13: warning: this ‘if’ clause does not guard... [-Wmisleading-indentation]
5280 | if(!presolve_fixSOS1(psdata, j, Value1, &iConRemove, &iVarFixed))
| ^~
lp_presolve.c:5282:15: note: ...this statement, but the latter is misleadingly indented as if it were guarded by the ‘if’
5282 | psdata->forceupdate = TRUE;
| ^~~~~~
lp_presolve.c: At top level:
lp_presolve.c:381:15: warning: ‘presolve_mustupdate’ defined but not used [-Wunused-function]
381 | INLINE MYBOOL presolve_mustupdate(lprec *lp, int colnr)
| ^~~~~~~~~~~~~~~~~~~
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_simplex.c -o lp_simplex.o
In file included from lp_simplex.c:27:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
In file included from include/random_walks/uniform_billiard_walk.hpp:17:
include/convex_bodies/hpolytope.h: In instantiation of ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&, VT&, VT&, const NT&, bool) const [with Point = point<Cartesian<double> >; typename Point::FT = double; VT = Eigen::Matrix<double, -1, 1>; NT = double]’:
include/convex_bodies/hpolytope.h:363:30: required from ‘std::pair<typename Point::FT, int> HPolytope<Point>::line_positive_intersect(const Point&, const Point&, VT&, VT&, const NT&) const [with Point = point<Cartesian<double> >; typename Point::FT = double; VT = Eigen::Matrix<double, -1, 1>; NT = double]’
363 | return line_intersect(r, v, Ar, Av, lambda_prev, true);
| ~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/zonoIntersecthpoly.h:134:66: required from ‘std::pair<typename CBall::NT, int> ZonoIntersectHPoly<Zonotope, HPolytope>::line_positive_intersect(const PointType&, const PointType&, VT&, VT&, const NT&) const [with Zonotope = Zonotope<point<Cartesian<double> > >; HPolytope = HPolytope<point<Cartesian<double> > >; typename CBall::NT = double; PointType = point<Cartesian<double> >; VT = Eigen::Matrix<double, -1, 1>; NT = double]’
134 | std::pair <NT, int> polypair = HP.line_positive_intersect(r, v, Ar, Av,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~
135 | lambda_prev);
| ~~~~~~~~~~~~
include/random_walks/uniform_billiard_walk.hpp:255:56: required from ‘void BilliardWalk::Walk<Polytope, RandomNumberGenerator>::apply(const GenericPolytope&, Point&, const unsigned int&, RandomNumberGenerator&) [with GenericPolytope = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; Polytope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>; Point = point<Cartesian<double> >]’
255 | auto pbpair = P.line_positive_intersect(_p, _v, _lambdas,
| ~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~
256 | _Av, _lambda_prev);
| ~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_balls.hpp:675:19: required from ‘NT estimate_ratio_interval(const PolyBall1&, const PolyBall2&, const NT&, const NT&, const int&, const int&, const NT&, const unsigned int&, RNG&) [with WalkType = BilliardWalk::Walk<Zonotope<point<Cartesian<double> > >, BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double> >; Point = point<Cartesian<double> >; PolyBall1 = ZonoIntersectHPoly<Zonotope<point<Cartesian<double> > >, HPolytope<point<Cartesian<double> > > >; PolyBall2 = HPolytope<point<Cartesian<double> > >; NT = double; RNG = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
675 | walk.apply(Pb1, p, walk_length, rng);
| ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~
include/volume/volume_cooling_hpoly.hpp:363:69: required from ‘double volume_cooling_hpoly(const Zonotope&, RandomNumberGenerator&, const double&, const unsigned int&, const unsigned int&) [with WalkTypePolicy = BilliardWalk; HPolytope = HPolytope<point<Cartesian<double> > >; Zonotope = Zonotope<point<Cartesian<double> > >; RandomNumberGenerator = BoostRandomNumberGenerator<boost::random::mersenne_twister_engine<unsigned int, 32, 624, 397, 31, 2567483615, 11, 4294967295, 7, 2636928640, 15, 4022730752, 18, 1812433253>, double>]’
363 | vol = vol / estimate_ratio_interval<WalkType, Point>(zb1, b2, ratios[i], er1, parameters.win_len,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
364 | N_times_nu, prob, walk_length, rng);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
zonotope_approximation.cpp:105:64: required from here
105 | vol = volume_cooling_hpoly<BilliardWalk, Hpolytope>(ZP, rng, e, walkL, win_len);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/hpolytope.h:313:12: warning: unused variable ‘mult’ [-Wunused-variable]
313 | NT mult;
| ^~~~
include/convex_bodies/hpolytope.h:315:22: warning: unused variable ‘j’ [-Wunused-variable]
315 | unsigned int j;
| ^
lp_simplex.c: In function ‘dualloop’:
lp_simplex.c:997:13: warning: variable ‘epsvalue’ set but not used [-Wunused-but-set-variable]
997 | LPSREAL epsvalue, xviolated, cviolated,
| ^~~~~~~~
In file included from lp_simplex.c:32:
../../headers/include/lp_presolve.h: At top level:
../../headers/include/lp_presolve.h:99:12: warning: ‘presolve_nextrow’ declared ‘static’ but never defined [-Wunused-function]
99 | INLINE int presolve_nextrow(presolverec *psdata, int colnr, int *previtem);
| ^~~~~~~~~~~~~~~~
../../headers/include/lp_presolve.h:100:12: warning: ‘presolve_nextcol’ declared ‘static’ but never defined [-Wunused-function]
100 | INLINE int presolve_nextcol(presolverec *psdata, int rownr, int *previtem);
| ^~~~~~~~~~~~~~~~
In file included from lp_simplex.c:33:
../../headers/include/lp_price.h:48:16: warning: ‘normalizeEdge’ declared ‘static’ but never defined [-Wunused-function]
48 | INLINE LPSREAL normalizeEdge(lprec *lp, int item, LPSREAL edge, MYBOOL isdual);
| ^~~~~~~~~~~~~
In file included from lp_simplex.c:34:
../../headers/include/lp_pricePSE.h:23:15: warning: ‘applyPricer’ declared ‘static’ but never defined [-Wunused-function]
23 | INLINE MYBOOL applyPricer(lprec *lp);
| ^~~~~~~~~~~
../../headers/include/lp_presolve.h:119:12: warning: ‘presolve_collength’ defined but not used [-Wunused-function]
119 | INLINE int presolve_collength(presolverec *psdata, int colnr)
| ^~~~~~~~~~~~~~~~~~
../../headers/include/lp_presolve.h:110:12: warning: ‘presolve_rowlength’ defined but not used [-Wunused-function]
110 | INLINE int presolve_rowlength(presolverec *psdata, int rownr)
| ^~~~~~~~~~~~~~~~~~
In file included from /usr/include/c++/15/bits/stl_algobase.h:64,
from /usr/include/c++/15/bits/specfun.h:43,
from /usr/include/c++/15/cmath:3913,
from /data/gannet/ripley/R/test-dev/Rcpp/include/Rcpp/platform/compiler.h:37,
from /data/gannet/ripley/R/test-dev/Rcpp/include/Rcpp/r/headers.h:66,
from /data/gannet/ripley/R/test-dev/Rcpp/include/RcppCommon.h:30,
from /data/gannet/ripley/R/test-dev/Rcpp/include/Rcpp.h:27,
from rounding.cpp:10:
In constructor ‘constexpr std::pair<_T1, _T2>::pair(_U1&&, _U2&&) [with _U1 = double&; _U2 = int&; typename std::enable_if<(std::_PCC<true, _T1, _T2>::_MoveConstructiblePair<_U1, _U2>() && std::_PCC<true, _T1, _T2>::_ImplicitlyMoveConvertiblePair<_U1, _U2>()), bool>::type <anonymous> = true; _T1 = double; _T2 = double]’,
inlined from ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&, VT&, VT&, const NT&, bool) const [with Point = point<Cartesian<double> >]’ at include/convex_bodies/hpolytope.h:339:30:
/usr/include/c++/15/bits/stl_pair.h:902:42: warning: ‘facet’ may be used uninitialized [-Wmaybe-uninitialized]
902 | : first(std::forward<_U1>(__x)), second(std::forward<_U2>(__y))
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/hpolytope.h: In function ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&, VT&, VT&, const NT&, bool) const [with Point = point<Cartesian<double> >]’:
include/convex_bodies/hpolytope.h:316:39: note: ‘facet’ was declared here
316 | int m = num_of_hyperplanes(), facet;
| ^~~~~
In constructor ‘constexpr std::pair<_T1, _T2>::pair(_U1&&, _U2&&) [with _U1 = double&; _U2 = int&; typename std::enable_if<(std::_PCC<true, _T1, _T2>::_MoveConstructiblePair<_U1, _U2>() && std::_PCC<true, _T1, _T2>::_ImplicitlyMoveConvertiblePair<_U1, _U2>()), bool>::type <anonymous> = true; _T1 = double; _T2 = double]’,
inlined from ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&, VT&, VT&, bool) const [with Point = point<Cartesian<double> >]’ at include/convex_bodies/hpolytope.h:299:30:
/usr/include/c++/15/bits/stl_pair.h:902:42: warning: ‘facet’ may be used uninitialized [-Wmaybe-uninitialized]
902 | : first(std::forward<_U1>(__x)), second(std::forward<_U2>(__y))
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/hpolytope.h: In member function ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&, VT&, VT&, bool) const [with Point = point<Cartesian<double> >]’:
include/convex_bodies/hpolytope.h:274:39: note: ‘facet’ was declared here
274 | int m = num_of_hyperplanes(), facet;
| ^~~~~
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c yacc_read.c -o yacc_read.o
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c ini.c -o ini.o
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_crash.c -o lp_crash.o
In file included from lp_crash.c:21:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_price.c -o lp_price.o
In file included from lp_price.c:3:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
In file included from ../../headers/include/myblas.h:20,
from lp_price.c:10:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
lp_price.c: In function ‘compareImprovementVar’:
lp_price.c:48:7: warning: variable ‘candidatecolno’ set but not used [-Wunused-but-set-variable]
48 | candidatecolno, candidatevarno = candidate->varno;
| ^~~~~~~~~~~~~~
lp_price.c:47:7: warning: variable ‘currentcolno’ set but not used [-Wunused-but-set-variable]
47 | int currentcolno, currentvarno = current->varno,
| ^~~~~~~~~~~~
lp_price.c: In function ‘compareSubstitutionVar’:
lp_price.c:161:10: warning: variable ‘candidatecolno’ set but not used [-Wunused-but-set-variable]
161 | candidatecolno, candidatevarno = candidate->varno;
| ^~~~~~~~~~~~~~
lp_price.c:160:10: warning: variable ‘currentcolno’ set but not used [-Wunused-but-set-variable]
160 | int currentcolno, currentvarno = current->varno,
| ^~~~~~~~~~~~
lp_price.c: In function ‘partial_findBlocks’:
lp_price.c:1561:15: warning: variable ‘blockdata’ set but not used [-Wunused-but-set-variable]
1561 | partialrec *blockdata;
| ^~~~~~~~~
In file included from lp_price.c:6:
../../headers/include/lp_pricePSE.h: At top level:
../../headers/include/lp_pricePSE.h:23:15: warning: ‘applyPricer’ declared ‘static’ but never defined [-Wunused-function]
23 | INLINE MYBOOL applyPricer(lprec *lp);
| ^~~~~~~~~~~
In file included from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Core:337,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Dense:1,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/RcppEigenForward.h:28,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/RcppEigen.h:25,
from rounding.cpp:11:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h: In function ‘static void Eigen::internal::selfadjoint_product_impl<Lhs, LhsMode, false, Rhs, 0, true>::run(Dest&, const Lhs&, const Rhs&, const Scalar&) [with Dest = Eigen::Block<Eigen::Matrix<double, -1, 1>, -1, 1, false>; Lhs = Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>; int LhsMode = 17; Rhs = Eigen::CwiseBinaryOp<Eigen::internal::scalar_product_op<double, double>, const Eigen::CwiseNullaryOp<Eigen::internal::scalar_constant_op<double>, const Eigen::Matrix<double, -1, 1> >, const Eigen::Block<Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, 1, true>, -1, 1, false> >]’:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h:229:7: warning: ‘result’ may be used uninitialized [-Wmaybe-uninitialized]
227 | internal::selfadjoint_matrix_vector_product<Scalar, Index, (internal::traits<ActualLhsTypeCleaned>::Flags&RowMajorBit) ? RowMajor : ColMajor,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
228 | int(LhsUpLo), bool(LhsBlasTraits::NeedToConjugate), bool(RhsBlasTraits::NeedToConjugate)>::run
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
229 | (
| ^
230 | lhs.rows(), // size
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
231 | &lhs.coeffRef(0,0), lhs.outerStride(), // lhs info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
232 | actualRhsPtr, // rhs info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
233 | actualDestPtr, // result info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
234 | actualAlpha // scale factor
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
235 | );
| ~
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h:41:6: note: by argument 4 of type ‘const double*’ to ‘static void Eigen::internal::selfadjoint_matrix_vector_product<Scalar, Index, StorageOrder, UpLo, ConjugateLhs, ConjugateRhs, Version>::run(Index, const Scalar*, Index, const Scalar*, Scalar*, Scalar) [with Scalar = double; Index = long int; int StorageOrder = 0; int UpLo = 1; bool ConjugateLhs = false; bool ConjugateRhs = false; int Version = 0]’ declared here
41 | void selfadjoint_matrix_vector_product<Scalar,Index,StorageOrder,UpLo,ConjugateLhs,ConjugateRhs,Version>::run(
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_utils.c -o lp_utils.o
In file included from lp_utils.c:4:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
lp_utils.c: In function ‘searchFor’:
lp_utils.c:533:5: warning: this ‘if’ clause does not guard... [-Wmisleading-indentation]
533 | if(absolute)
| ^~
lp_utils.c:535:7: note: ...this statement, but the latter is misleadingly indented as if it were guarded by the ‘if’
535 | while((beginPos < endPos) && (match != target)) {
| ^~~~~
lp_utils.c: In function ‘compareLink’:
lp_utils.c:929:3: warning: this ‘if’ clause does not guard... [-Wmisleading-indentation]
929 | if(test == 0)
| ^~
lp_utils.c:931:5: note: ...this statement, but the latter is misleadingly indented as if it were guarded by the ‘if’
931 | if(test == 0)
| ^~
In file included from lp_utils.c:9:
../../headers/include/lp_bit.h: At top level:
../../headers/include/lp_bit.h:28:17: warning: ‘is_biton’ defined but not used [-Wunused-function]
28 | MYINLINE MYBOOL is_biton(MYBOOL *bitarray, int item)
| ^~~~~~~~
../../headers/include/lp_bit.h:23:15: warning: ‘set_bitoff’ defined but not used [-Wunused-function]
23 | MYINLINE void set_bitoff(MYBOOL *bitarray, int item)
| ^~~~~~~~~~
../../headers/include/lp_bit.h:18:15: warning: ‘set_biton’ defined but not used [-Wunused-function]
18 | MYINLINE void set_biton(MYBOOL *bitarray, int item)
| ^~~~~~~~~
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_Hash.c -o lp_Hash.o
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_lib.c -o lp_lib.o
In file included from lp_lib.c:42:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
In file included from ../../headers/include/lusol.h:17,
from ../../headers/include/lp_LUSOL.h:15,
from lp_lib.c:60:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
lp_lib.c: In function ‘set_BFP’:
lp_lib.c:5366:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5366 | lp->bfp_compatible = (BFPbool_lpintintint *)
| ^
lp_lib.c:5372:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5372 | lp->bfp_name = (BFPchar *)
| ^
lp_lib.c:5374:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5374 | lp->bfp_free = (BFP_lp *)
| ^
lp_lib.c:5376:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5376 | lp->bfp_resize = (BFPbool_lpint *)
| ^
lp_lib.c:5378:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5378 | lp->bfp_nonzeros = (BFPint_lpbool *)
| ^
lp_lib.c:5380:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5380 | lp->bfp_memallocated = (BFPint_lp *)
| ^
lp_lib.c:5382:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5382 | lp->bfp_restart = (BFPbool_lp *)
| ^
lp_lib.c:5384:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5384 | lp->bfp_mustrefactorize = (BFPbool_lp *)
| ^
lp_lib.c:5386:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5386 | lp->bfp_preparefactorization = (BFPint_lp *)
| ^
lp_lib.c:5388:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5388 | lp->bfp_factorize = (BFPint_lpintintboolbool *)
| ^
lp_lib.c:5390:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5390 | lp->bfp_finishupdate = (BFPbool_lpbool *)
| ^
lp_lib.c:5392:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5392 | lp->bfp_ftran_normal = (BFP_lprealint *)
| ^
lp_lib.c:5394:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5394 | lp->bfp_ftran_prepare = (BFP_lprealint *)
| ^
lp_lib.c:5396:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5396 | lp->bfp_btran_normal = (BFP_lprealint *)
| ^
lp_lib.c:5398:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5398 | lp->bfp_status = (BFPint_lp *)
| ^
lp_lib.c:5400:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5400 | lp->bfp_implicitslack = (BFPbool_lp *)
| ^
lp_lib.c:5402:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5402 | lp->bfp_indexbase = (BFPint_lp *)
| ^
lp_lib.c:5404:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5404 | lp->bfp_rowoffset = (BFPint_lp *)
| ^
lp_lib.c:5406:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5406 | lp->bfp_pivotmax = (BFPint_lp *)
| ^
lp_lib.c:5408:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5408 | lp->bfp_init = (BFPbool_lpintintchar *)
| ^
lp_lib.c:5410:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5410 | lp->bfp_pivotalloc = (BFPbool_lpint *)
| ^
lp_lib.c:5412:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5412 | lp->bfp_colcount = (BFPint_lp *)
| ^
lp_lib.c:5414:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5414 | lp->bfp_canresetbasis = (BFPbool_lp *)
| ^
lp_lib.c:5416:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5416 | lp->bfp_finishfactorization = (BFP_lp *)
| ^
lp_lib.c:5418:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5418 | lp->bfp_updaterefactstats = (BFP_lp *)
| ^
lp_lib.c:5420:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5420 | lp->bfp_prepareupdate = (BFPlreal_lpintintreal *)
| ^
lp_lib.c:5422:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5422 | lp->bfp_pivotRHS = (BFPreal_lplrealreal *)
| ^
lp_lib.c:5424:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5424 | lp->bfp_btran_double = (BFP_lprealintrealint *)
| ^
lp_lib.c:5426:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5426 | lp->bfp_efficiency = (BFPreal_lp *)
| ^
lp_lib.c:5428:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5428 | lp->bfp_pivotvector = (BFPrealp_lp *)
| ^
lp_lib.c:5430:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5430 | lp->bfp_pivotcount = (BFPint_lp *)
| ^
lp_lib.c:5432:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5432 | lp->bfp_refactcount = (BFPint_lpint *)
| ^
lp_lib.c:5434:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5434 | lp->bfp_isSetI = (BFPbool_lp *)
| ^
lp_lib.c:5436:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5436 | lp->bfp_findredundant = (BFPint_lpintrealcbintint *)
| ^
lp_lib.c: In function ‘set_XLI’:
lp_lib.c:5626:38: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5626 | lp->xli_compatible = (XLIbool_lpintintint *)
| ^
lp_lib.c:5632:40: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5632 | lp->xli_name = (XLIchar *)
| ^
lp_lib.c:5634:40: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5634 | lp->xli_readmodel = (XLIbool_lpcharcharcharint *)
| ^
lp_lib.c:5636:40: warning: ISO C forbids conversion of object pointer to function pointer type [-Wpedantic]
5636 | lp->xli_writemodel = (XLIbool_lpcharcharbool *)
| ^
lp_lib.c: In function ‘get_origrow_name’:
lp_lib.c:6057:10: warning: variable ‘newrow’ set but not used [-Wunused-but-set-variable]
6057 | MYBOOL newrow;
| ^~~~~~
lp_lib.c: In function ‘get_origcol_name’:
lp_lib.c:6122:10: warning: variable ‘newcol’ set but not used [-Wunused-but-set-variable]
6122 | MYBOOL newcol;
| ^~~~~~
lp_lib.c: In function ‘verify_basis’:
lp_lib.c:7023:17: warning: variable ‘k’ set but not used [-Wunused-but-set-variable]
7023 | int i, ii, k = 0;
| ^
In file included from lp_lib.c:49:
../../headers/include/lp_presolve.h: At top level:
../../headers/include/lp_presolve.h:99:12: warning: ‘presolve_nextrow’ declared ‘static’ but never defined [-Wunused-function]
99 | INLINE int presolve_nextrow(presolverec *psdata, int colnr, int *previtem);
| ^~~~~~~~~~~~~~~~
../../headers/include/lp_presolve.h:100:12: warning: ‘presolve_nextcol’ declared ‘static’ but never defined [-Wunused-function]
100 | INLINE int presolve_nextcol(presolverec *psdata, int rownr, int *previtem);
| ^~~~~~~~~~~~~~~~
In file included from lp_lib.c:82:
../../headers/include/lp_price.h:48:16: warning: ‘normalizeEdge’ declared ‘static’ but never defined [-Wunused-function]
48 | INLINE LPSREAL normalizeEdge(lprec *lp, int item, LPSREAL edge, MYBOOL isdual);
| ^~~~~~~~~~~~~
In file included from lp_lib.c:83:
../../headers/include/lp_pricePSE.h:23:15: warning: ‘applyPricer’ declared ‘static’ but never defined [-Wunused-function]
23 | INLINE MYBOOL applyPricer(lprec *lp);
| ^~~~~~~~~~~
In file included from lp_lib.c:55:
../../headers/include/lp_bit.h:23:15: warning: ‘set_bitoff’ defined but not used [-Wunused-function]
23 | MYINLINE void set_bitoff(MYBOOL *bitarray, int item)
| ^~~~~~~~~~
../../headers/include/lp_presolve.h:119:12: warning: ‘presolve_collength’ defined but not used [-Wunused-function]
119 | INLINE int presolve_collength(presolverec *psdata, int colnr)
| ^~~~~~~~~~~~~~~~~~
../../headers/include/lp_presolve.h:110:12: warning: ‘presolve_rowlength’ defined but not used [-Wunused-function]
110 | INLINE int presolve_rowlength(presolverec *psdata, int rownr)
| ^~~~~~~~~~~~~~~~~~
In file included from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Core:341:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h: In function ‘static void Eigen::internal::trmv_selector<Mode, 1>::run(const Lhs&, const Rhs&, Dest&, const typename Dest::Scalar&) [with Lhs = Eigen::Transpose<const Eigen::Block<const Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>, -1, -1, false> >; Rhs = Eigen::Transpose<const Eigen::CwiseBinaryOp<Eigen::internal::scalar_product_op<double, double>, const Eigen::CwiseNullaryOp<Eigen::internal::scalar_constant_op<double>, const Eigen::Matrix<double, 1, -1> >, const Eigen::Transpose<const Eigen::Block<const Eigen::Block<const Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>, -1, 1, true>, -1, 1, false> > > >; Dest = Eigen::Transpose<Eigen::Block<Eigen::Block<Eigen::Matrix<double, -1, -1, 1, -1, -1>, 1, -1, true>, 1, -1, false> >; int Mode = 6]’:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h:332:12: warning: ‘result’ may be used uninitialized [-Wmaybe-uninitialized]
327 | internal::triangular_matrix_vector_product
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
328 | <Index,Mode,
| ~~~~~~~~~~~~
329 | LhsScalar, LhsBlasTraits::NeedToConjugate,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
330 | RhsScalar, RhsBlasTraits::NeedToConjugate,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
331 | RowMajor>
| ~~~~~~~~~
332 | ::run(actualLhs.rows(),actualLhs.cols(),
| ~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
333 | actualLhs.data(),actualLhs.outerStride(),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
334 | actualRhsPtr,1,
| ~~~~~~~~~~~~~~~
335 | dest.data(),dest.innerStride(),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
336 | actualAlpha);
| ~~~~~~~~~~~~
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h:105:24: note: by argument 5 of type ‘const double*’ to ‘static void Eigen::internal::triangular_matrix_vector_product<Index, Mode, LhsScalar, ConjLhs, RhsScalar, ConjRhs, 1, Version>::run(Index, Index, const LhsScalar*, Index, const RhsScalar*, Index, ResScalar*, Index, const ResScalar&) [with Index = long int; int Mode = 6; LhsScalar = double; bool ConjLhs = false; RhsScalar = double; bool ConjRhs = false; int Version = 0]’ declared here
105 | EIGEN_DONT_INLINE void triangular_matrix_vector_product<Index,Mode,LhsScalar,ConjLhs,RhsScalar,ConjRhs,RowMajor,Version>
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_pricePSE.c -o lp_pricePSE.o
In file included from lp_pricePSE.c:3:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_wlp.c -o lp_wlp.o
In file included from lp_wlp.c:14:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
lp_wlp.c: In function ‘write_lprow’:
lp_wlp.c:55:14: warning: variable ‘a’ set but not used [-Wunused-but-set-variable]
55 | LPSREAL a;
| ^
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_LUSOL.c -o lp_LUSOL.o
In file included from ../../headers/include/myblas.h:20,
from lp_LUSOL.c:27:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
In file included from lp_LUSOL.c:28:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
lp_LUSOL.c: In function ‘bfp_LUSOLsetcolumn’:
lp_LUSOL.c:209:7: warning: variable ‘nz’ set but not used [-Wunused-but-set-variable]
209 | int nz, inform;
| ^~
lp_LUSOL.c: In function ‘bfp_finishupdate’:
lp_LUSOL.c:477:18: warning: variable ‘kcol’ set but not used [-Wunused-but-set-variable]
477 | int i, k, kcol, deltarows = bfp_rowoffset(lp);
| ^~~~
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_matrix.c -o lp_matrix.o
In file included from lp_matrix.c:11:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
lp_matrix.c: In function ‘inc_matrow_space’:
lp_matrix.c:205:18: warning: variable ‘oldrowsalloc’ set but not used [-Wunused-but-set-variable]
205 | int rowsum, oldrowsalloc;
| ^~~~~~~~~~~~
lp_matrix.c: In function ‘prod_Ax’:
lp_matrix.c:3329:34: warning: variable ‘ve’ set but not used [-Wunused-but-set-variable]
3329 | int j, colnr, ib, ie, vb, ve;
| ^~
In file included from lp_matrix.c:15:
../../headers/include/lp_price.h: At top level:
../../headers/include/lp_price.h:48:16: warning: ‘normalizeEdge’ declared ‘static’ but never defined [-Wunused-function]
48 | INLINE LPSREAL normalizeEdge(lprec *lp, int item, LPSREAL edge, MYBOOL isdual);
| ^~~~~~~~~~~~~
In file included from lp_matrix.c:16:
../../headers/include/lp_pricePSE.h:23:15: warning: ‘applyPricer’ declared ‘static’ but never defined [-Wunused-function]
23 | INLINE MYBOOL applyPricer(lprec *lp);
| ^~~~~~~~~~~
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lp_report.c -o lp_report.o
In file included from lp_report.c:25:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
lp_report.c: In function ‘blockWriteAMAT’:
lp_report.c:186:10: warning: variable ‘hold’ set but not used [-Wunused-but-set-variable]
186 | double hold;
| ^~~~
lp_report.c: In function ‘REPORT_duals’:
lp_report.c:317:10: warning: variable ‘ret’ set but not used [-Wunused-but-set-variable]
317 | MYBOOL ret;
| ^~~
lp_report.c:315:7: warning: unused variable ‘i’ [-Wunused-variable]
315 | int i;
| ^
lp_report.c: In function ‘REPORT_scales’:
lp_report.c:407:10: warning: variable ‘colMax’ set but not used [-Wunused-but-set-variable]
407 | int i, colMax;
| ^~~~~~
lp_report.c:407:7: warning: unused variable ‘i’ [-Wunused-variable]
407 | int i, colMax;
| ^
lp_report.c: In function ‘REPORT_tableau’:
lp_report.c:430:9: warning: unused variable ‘stream’ [-Wunused-variable]
430 | FILE *stream;// = lp->outstream;
| ^~~~~~
lp_report.c:428:8: warning: unused variable ‘j’ [-Wunused-variable]
428 | int j, row_nr, *coltarget;
| ^
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c lusol.c -o lusol.o
In file included from ../../headers/include/lusol.h:17,
from lusol.c:50:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
lusol.c: In function ‘LUSOL_report’:
lusol.c:648:12: warning: unused variable ‘buff’ [-Wunused-variable]
648 | char buff[255];
| ^~~~
In file included from lusol.c:756:
lusol6a.c: In function ‘LU6CHK’:
lusol6a.c:197:59: warning: variable ‘NDEFIC’ set but not used [-Wunused-but-set-variable]
197 | int I, J, JUMIN, K, L, L1, L2, LENL, LDIAGU, LPRINT, NDEFIC, NRANK;
| ^~~~~~
lusol6a.c:197:51: warning: variable ‘LPRINT’ set but not used [-Wunused-but-set-variable]
197 | int I, J, JUMIN, K, L, L1, L2, LENL, LDIAGU, LPRINT, NDEFIC, NRANK;
| ^~~~~~
In file included from lusol.c:757:
lusol1.c: In function ‘LU1FAC’:
lusol1.c:3359:34: warning: variable ‘TSP’ set but not used [-Wunused-but-set-variable]
3359 | MYBOOL KEEPLU, TCP, TPP, TRP, TSP;
| ^~~
lusol1.c:3359:29: warning: variable ‘TRP’ set but not used [-Wunused-but-set-variable]
3359 | MYBOOL KEEPLU, TCP, TPP, TRP, TSP;
| ^~~
lusol1.c:3359:19: warning: variable ‘TCP’ set but not used [-Wunused-but-set-variable]
3359 | MYBOOL KEEPLU, TCP, TPP, TRP, TSP;
| ^~~
In file included from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Core:309:
In constructor ‘Eigen::internal::BlockImpl_dense<XprType, BlockRows, BlockCols, InnerPanel, true>::BlockImpl_dense(XprType&, Eigen::Index) [with XprType = const Eigen::Matrix<double, -1, -1>; int BlockRows = 1; int BlockCols = -1; bool InnerPanel = false]’,
inlined from ‘Eigen::BlockImpl<XprType, BlockRows, BlockCols, InnerPanel, Eigen::Dense>::BlockImpl(XprType&, Eigen::Index) [with XprType = const Eigen::Matrix<double, -1, -1>; int BlockRows = 1; int BlockCols = -1; bool InnerPanel = false]’ at /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/Block.h:162:88,
inlined from ‘Eigen::Block<XprType, BlockRows, BlockCols, InnerPanel>::Block(XprType&, Eigen::Index) [with XprType = const Eigen::Matrix<double, -1, -1>; int BlockRows = 1; int BlockCols = -1; bool InnerPanel = false]’ at /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/Block.h:118:46,
inlined from ‘Eigen::DenseBase<Derived>::ConstRowXpr Eigen::DenseBase<Derived>::row(Eigen::Index) const [with Derived = Eigen::Matrix<double, -1, -1>]’ at /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/../plugins/BlockMethods.h:1127:34,
inlined from ‘void VPolytope<Point>::compute_reflection(Point&, const Point&, const int&) const [with Point = point<Cartesian<double> >]’ at include/convex_bodies/vpolytope.h:435:24:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/Block.h:347:29: warning: ‘outvert’ may be used uninitialized [-Wmaybe-uninitialized]
347 | : Base(xpr.data() + i * ( ((BlockRows==1) && (BlockCols==XprType::ColsAtCompileTime) && (!XprTypeIsRowMajor))
| ~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
348 | || ((BlockRows==XprType::RowsAtCompileTime) && (BlockCols==1) && ( XprTypeIsRowMajor)) ? xpr.innerStride() : xpr.outerStride()),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/vpolytope.h: In function ‘void VPolytope<Point>::compute_reflection(Point&, const Point&, const int&) const [with Point = point<Cartesian<double> >]’:
include/convex_bodies/vpolytope.h:423:24: note: ‘outvert’ was declared here
423 | int count = 0, outvert;
| ^~~~~~~
gcc -g -O2 -Wall -pedantic -mtune=native -Wp,-D_FORTIFY_SOURCE=3 -fexceptions -fstack-protector-strong -fstack-clash-protection -fcf-protection -Werror=implicit-function-declaration -Wstrict-prototypes -fpic -I/usr/local/include -I../../headers/include -I/data/gannet/ripley/R/R-devel/include -DYY_NEVER_INTERACTIVE -DPARSER_LP -DINVERSE_ACTIVE=INVERSE_LUSOL -DRoleIsExternalInvEngine -c myblas.c -o myblas.o
In file included from ../../headers/include/myblas.h:20,
from myblas.c:7:
../../headers/include/commonlib.h:135:5: warning: multi-line comment [-Wcomment]
135 | //printf("calloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:143:5: warning: multi-line comment [-Wcomment]
143 | //printf("malloc of %d bytes failed on line %d of file %s\n",\
| ^
../../headers/include/commonlib.h:151:5: warning: multi-line comment [-Wcomment]
151 | //printf("realloc of %d bytes failed on line %d of file %s\n",\
| ^
gcc-ar rc liblp_solve.a colamd.o lp_MDO.o lp_mipbb.o lp_rlp.o mmio.o commonlib.o lp_MPS.o lp_params.o lp_scale.o lp_SOS.o lp_presolve.o lp_simplex.o yacc_read.o ini.o lp_crash.o lp_price.o lp_utils.o lp_Hash.o lp_lib.o lp_pricePSE.o lp_wlp.o lp_LUSOL.o lp_matrix.o lp_report.o lusol.o myblas.o && gcc-ranlib liblp_solve.a
make[2]: Leaving directory '/data/gannet/ripley/R/packages/tests-devel/volesti/src/external/lpsolve/build/lp_solve'
In file included from /usr/include/c++/15/bits/stl_algobase.h:64,
from /usr/include/c++/15/bits/specfun.h:43,
from /usr/include/c++/15/cmath:3913,
from /data/gannet/ripley/R/test-dev/Rcpp/include/Rcpp/platform/compiler.h:37,
from /data/gannet/ripley/R/test-dev/Rcpp/include/Rcpp/r/headers.h:66,
from /data/gannet/ripley/R/test-dev/Rcpp/include/RcppCommon.h:30,
from /data/gannet/ripley/R/test-dev/Rcpp/include/Rcpp.h:27,
from sample_points.cpp:10:
In constructor ‘constexpr std::pair<_T1, _T2>::pair(_U1&&, _U2&&) [with _U1 = double&; _U2 = int&; typename std::enable_if<(std::_PCC<true, _T1, _T2>::_MoveConstructiblePair<_U1, _U2>() && std::_PCC<true, _T1, _T2>::_ImplicitlyMoveConvertiblePair<_U1, _U2>()), bool>::type <anonymous> = true; _T1 = double; _T2 = double]’,
inlined from ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&, VT&, VT&, bool) const [with Point = point<Cartesian<double> >]’ at include/convex_bodies/hpolytope.h:299:30:
/usr/include/c++/15/bits/stl_pair.h:902:42: warning: ‘facet’ may be used uninitialized [-Wmaybe-uninitialized]
902 | : first(std::forward<_U1>(__x)), second(std::forward<_U2>(__y))
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/hpolytope.h: In member function ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&, VT&, VT&, bool) const [with Point = point<Cartesian<double> >]’:
include/convex_bodies/hpolytope.h:274:39: note: ‘facet’ was declared here
274 | int m = num_of_hyperplanes(), facet;
| ^~~~~
In constructor ‘constexpr std::pair<_T1, _T2>::pair(_U1&&, _U2&&) [with _U1 = double&; _U2 = int&; typename std::enable_if<(std::_PCC<true, _T1, _T2>::_MoveConstructiblePair<_U1, _U2>() && std::_PCC<true, _T1, _T2>::_ImplicitlyMoveConvertiblePair<_U1, _U2>()), bool>::type <anonymous> = true; _T1 = double; _T2 = double]’,
inlined from ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&, VT&, VT&, const NT&, bool) const [with Point = point<Cartesian<double> >]’ at include/convex_bodies/hpolytope.h:339:30:
/usr/include/c++/15/bits/stl_pair.h:902:42: warning: ‘facet’ may be used uninitialized [-Wmaybe-uninitialized]
902 | : first(std::forward<_U1>(__x)), second(std::forward<_U2>(__y))
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/hpolytope.h: In function ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&, VT&, VT&, const NT&, bool) const [with Point = point<Cartesian<double> >]’:
include/convex_bodies/hpolytope.h:316:39: note: ‘facet’ was declared here
316 | int m = num_of_hyperplanes(), facet;
| ^~~~~
In file included from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Core:309,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Dense:1,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/RcppEigenForward.h:28,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/RcppEigen.h:25,
from sample_points.cpp:11:
In constructor ‘Eigen::internal::BlockImpl_dense<XprType, BlockRows, BlockCols, InnerPanel, true>::BlockImpl_dense(XprType&, Eigen::Index) [with XprType = const Eigen::Matrix<double, -1, -1>; int BlockRows = 1; int BlockCols = -1; bool InnerPanel = false]’,
inlined from ‘Eigen::BlockImpl<XprType, BlockRows, BlockCols, InnerPanel, Eigen::Dense>::BlockImpl(XprType&, Eigen::Index) [with XprType = const Eigen::Matrix<double, -1, -1>; int BlockRows = 1; int BlockCols = -1; bool InnerPanel = false]’ at /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/Block.h:162:88,
inlined from ‘Eigen::Block<XprType, BlockRows, BlockCols, InnerPanel>::Block(XprType&, Eigen::Index) [with XprType = const Eigen::Matrix<double, -1, -1>; int BlockRows = 1; int BlockCols = -1; bool InnerPanel = false]’ at /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/Block.h:118:46,
inlined from ‘Eigen::DenseBase<Derived>::ConstRowXpr Eigen::DenseBase<Derived>::row(Eigen::Index) const [with Derived = Eigen::Matrix<double, -1, -1>]’ at /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/../plugins/BlockMethods.h:1127:34,
inlined from ‘void VPolytope<Point>::compute_reflection(Point&, const Point&, const int&) const [with Point = point<Cartesian<double> >]’ at include/convex_bodies/vpolytope.h:435:24:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/Block.h:347:29: warning: ‘outvert’ may be used uninitialized [-Wmaybe-uninitialized]
347 | : Base(xpr.data() + i * ( ((BlockRows==1) && (BlockCols==XprType::ColsAtCompileTime) && (!XprTypeIsRowMajor))
| ~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
348 | || ((BlockRows==XprType::RowsAtCompileTime) && (BlockCols==1) && ( XprTypeIsRowMajor)) ? xpr.innerStride() : xpr.outerStride()),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/vpolytope.h: In function ‘void VPolytope<Point>::compute_reflection(Point&, const Point&, const int&) const [with Point = point<Cartesian<double> >]’:
include/convex_bodies/vpolytope.h:423:24: note: ‘outvert’ was declared here
423 | int count = 0, outvert;
| ^~~~~~~
In file included from include/random_walks/uniform_billiard_walk.hpp:21:
include/convex_bodies/zonoIntersecthpoly.h: In member function ‘std::pair<typename CBall::NT, int> ZonoIntersectHPoly<Zonotope, HPolytope>::line_positive_intersect(const PointType&, const PointType&, VT&, VT&) const [with Zonotope = Zonotope<point<Cartesian<double> > >; HPolytope = HPolytope<point<Cartesian<double> > >]’:
include/convex_bodies/zonoIntersecthpoly.h:125:82: warning: ‘facet’ may be used uninitialized [-Wmaybe-uninitialized]
125 | return std::pair<NT, int>(std::min(polypair.first, zonopair.first), facet);
| ^
include/convex_bodies/hpolytope.h:274:39: note: ‘facet’ was declared here
274 | int m = num_of_hyperplanes(), facet;
| ^~~~~
include/convex_bodies/zonoIntersecthpoly.h: In function ‘std::pair<typename CBall::NT, int> ZonoIntersectHPoly<Zonotope, HPolytope>::line_positive_intersect(const PointType&, const PointType&, VT&, VT&, const NT&) const [with Zonotope = Zonotope<point<Cartesian<double> > >; HPolytope = HPolytope<point<Cartesian<double> > >]’:
include/convex_bodies/zonoIntersecthpoly.h:142:40: warning: ‘facet’ may be used uninitialized [-Wmaybe-uninitialized]
142 | facet);
| ^
include/convex_bodies/hpolytope.h:316:39: note: ‘facet’ was declared here
316 | int m = num_of_hyperplanes(), facet;
| ^~~~~
In file included from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Core:337,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Dense:1,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/RcppEigenForward.h:28,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/RcppEigen.h:25,
from zonotope_approximation.cpp:9:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h: In function ‘static void Eigen::internal::selfadjoint_product_impl<Lhs, LhsMode, false, Rhs, 0, true>::run(Dest&, const Lhs&, const Rhs&, const Scalar&) [with Dest = Eigen::Block<Eigen::Matrix<double, -1, 1>, -1, 1, false>; Lhs = Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>; int LhsMode = 17; Rhs = Eigen::CwiseBinaryOp<Eigen::internal::scalar_product_op<double, double>, const Eigen::CwiseNullaryOp<Eigen::internal::scalar_constant_op<double>, const Eigen::Matrix<double, -1, 1> >, const Eigen::Block<Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, 1, true>, -1, 1, false> >]’:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h:229:7: warning: ‘result’ may be used uninitialized [-Wmaybe-uninitialized]
227 | internal::selfadjoint_matrix_vector_product<Scalar, Index, (internal::traits<ActualLhsTypeCleaned>::Flags&RowMajorBit) ? RowMajor : ColMajor,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
228 | int(LhsUpLo), bool(LhsBlasTraits::NeedToConjugate), bool(RhsBlasTraits::NeedToConjugate)>::run
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
229 | (
| ^
230 | lhs.rows(), // size
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
231 | &lhs.coeffRef(0,0), lhs.outerStride(), // lhs info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
232 | actualRhsPtr, // rhs info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
233 | actualDestPtr, // result info
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
234 | actualAlpha // scale factor
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
235 | );
| ~
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/SelfadjointMatrixVector.h:41:6: note: by argument 4 of type ‘const double*’ to ‘static void Eigen::internal::selfadjoint_matrix_vector_product<Scalar, Index, StorageOrder, UpLo, ConjugateLhs, ConjugateRhs, Version>::run(Index, const Scalar*, Index, const Scalar*, Scalar*, Scalar) [with Scalar = double; Index = long int; int StorageOrder = 0; int UpLo = 1; bool ConjugateLhs = false; bool ConjugateRhs = false; int Version = 0]’ declared here
41 | void selfadjoint_matrix_vector_product<Scalar,Index,StorageOrder,UpLo,ConjugateLhs,ConjugateRhs,Version>::run(
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
In file included from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Core:341:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h: In function ‘static void Eigen::internal::trmv_selector<Mode, 1>::run(const Lhs&, const Rhs&, Dest&, const typename Dest::Scalar&) [with Lhs = Eigen::Transpose<const Eigen::Block<const Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>, -1, -1, false> >; Rhs = Eigen::Transpose<const Eigen::CwiseBinaryOp<Eigen::internal::scalar_product_op<double, double>, const Eigen::CwiseNullaryOp<Eigen::internal::scalar_constant_op<double>, const Eigen::Matrix<double, 1, -1> >, const Eigen::Transpose<const Eigen::Block<const Eigen::Block<const Eigen::Block<Eigen::Matrix<double, -1, -1>, -1, -1, false>, -1, 1, true>, -1, 1, false> > > >; Dest = Eigen::Transpose<Eigen::Block<Eigen::Block<Eigen::Matrix<double, -1, -1, 1, -1, -1>, 1, -1, true>, 1, -1, false> >; int Mode = 6]’:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h:332:12: warning: ‘result’ may be used uninitialized [-Wmaybe-uninitialized]
327 | internal::triangular_matrix_vector_product
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
328 | <Index,Mode,
| ~~~~~~~~~~~~
329 | LhsScalar, LhsBlasTraits::NeedToConjugate,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
330 | RhsScalar, RhsBlasTraits::NeedToConjugate,
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
331 | RowMajor>
| ~~~~~~~~~
332 | ::run(actualLhs.rows(),actualLhs.cols(),
| ~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
333 | actualLhs.data(),actualLhs.outerStride(),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
334 | actualRhsPtr,1,
| ~~~~~~~~~~~~~~~
335 | dest.data(),dest.innerStride(),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
336 | actualAlpha);
| ~~~~~~~~~~~~
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/products/TriangularMatrixVector.h:105:24: note: by argument 5 of type ‘const double*’ to ‘static void Eigen::internal::triangular_matrix_vector_product<Index, Mode, LhsScalar, ConjLhs, RhsScalar, ConjRhs, 1, Version>::run(Index, Index, const LhsScalar*, Index, const RhsScalar*, Index, ResScalar*, Index, const ResScalar&) [with Index = long int; int Mode = 6; LhsScalar = double; bool ConjLhs = false; RhsScalar = double; bool ConjRhs = false; int Version = 0]’ declared here
105 | EIGEN_DONT_INLINE void triangular_matrix_vector_product<Index,Mode,LhsScalar,ConjLhs,RhsScalar,ConjRhs,RowMajor,Version>
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
In file included from /usr/include/c++/15/bits/stl_algobase.h:64,
from /usr/include/c++/15/bits/specfun.h:43,
from /usr/include/c++/15/cmath:3913,
from /data/gannet/ripley/R/test-dev/Rcpp/include/Rcpp/platform/compiler.h:37,
from /data/gannet/ripley/R/test-dev/Rcpp/include/Rcpp/r/headers.h:66,
from /data/gannet/ripley/R/test-dev/Rcpp/include/RcppCommon.h:30,
from /data/gannet/ripley/R/test-dev/Rcpp/include/Rcpp.h:27,
from volume.cpp:10:
In constructor ‘constexpr std::pair<_T1, _T2>::pair(_U1&&, _U2&&) [with _U1 = double&; _U2 = int&; typename std::enable_if<(std::_PCC<true, _T1, _T2>::_MoveConstructiblePair<_U1, _U2>() && std::_PCC<true, _T1, _T2>::_ImplicitlyMoveConvertiblePair<_U1, _U2>()), bool>::type <anonymous> = true; _T1 = double; _T2 = double]’,
inlined from ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&, VT&, VT&, bool) const [with Point = point<Cartesian<double> >]’ at include/convex_bodies/hpolytope.h:299:30:
/usr/include/c++/15/bits/stl_pair.h:902:42: warning: ‘facet’ may be used uninitialized [-Wmaybe-uninitialized]
902 | : first(std::forward<_U1>(__x)), second(std::forward<_U2>(__y))
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/hpolytope.h: In member function ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&, VT&, VT&, bool) const [with Point = point<Cartesian<double> >]’:
include/convex_bodies/hpolytope.h:274:39: note: ‘facet’ was declared here
274 | int m = num_of_hyperplanes(), facet;
| ^~~~~
In constructor ‘constexpr std::pair<_T1, _T2>::pair(_U1&&, _U2&&) [with _U1 = double&; _U2 = int&; typename std::enable_if<(std::_PCC<true, _T1, _T2>::_MoveConstructiblePair<_U1, _U2>() && std::_PCC<true, _T1, _T2>::_ImplicitlyMoveConvertiblePair<_U1, _U2>()), bool>::type <anonymous> = true; _T1 = double; _T2 = double]’,
inlined from ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&, VT&, VT&, const NT&, bool) const [with Point = point<Cartesian<double> >]’ at include/convex_bodies/hpolytope.h:339:30:
/usr/include/c++/15/bits/stl_pair.h:902:42: warning: ‘facet’ may be used uninitialized [-Wmaybe-uninitialized]
902 | : first(std::forward<_U1>(__x)), second(std::forward<_U2>(__y))
| ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/hpolytope.h: In function ‘std::pair<typename Point::FT, typename Point::FT> HPolytope<Point>::line_intersect(const Point&, const Point&, VT&, VT&, const NT&, bool) const [with Point = point<Cartesian<double> >]’:
include/convex_bodies/hpolytope.h:316:39: note: ‘facet’ was declared here
316 | int m = num_of_hyperplanes(), facet;
| ^~~~~
In file included from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Core:309,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/Dense:1,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/RcppEigenForward.h:28,
from /data/gannet/ripley/R/test-dev/RcppEigen/include/RcppEigen.h:25,
from volume.cpp:11:
In constructor ‘Eigen::internal::BlockImpl_dense<XprType, BlockRows, BlockCols, InnerPanel, true>::BlockImpl_dense(XprType&, Eigen::Index) [with XprType = const Eigen::Matrix<double, -1, -1>; int BlockRows = 1; int BlockCols = -1; bool InnerPanel = false]’,
inlined from ‘Eigen::BlockImpl<XprType, BlockRows, BlockCols, InnerPanel, Eigen::Dense>::BlockImpl(XprType&, Eigen::Index) [with XprType = const Eigen::Matrix<double, -1, -1>; int BlockRows = 1; int BlockCols = -1; bool InnerPanel = false]’ at /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/Block.h:162:88,
inlined from ‘Eigen::Block<XprType, BlockRows, BlockCols, InnerPanel>::Block(XprType&, Eigen::Index) [with XprType = const Eigen::Matrix<double, -1, -1>; int BlockRows = 1; int BlockCols = -1; bool InnerPanel = false]’ at /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/Block.h:118:46,
inlined from ‘Eigen::DenseBase<Derived>::ConstRowXpr Eigen::DenseBase<Derived>::row(Eigen::Index) const [with Derived = Eigen::Matrix<double, -1, -1>]’ at /data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/../plugins/BlockMethods.h:1127:34,
inlined from ‘void VPolytope<Point>::compute_reflection(Point&, const Point&, const int&) const [with Point = point<Cartesian<double> >]’ at include/convex_bodies/vpolytope.h:435:24:
/data/gannet/ripley/R/test-dev/RcppEigen/include/Eigen/src/Core/Block.h:347:29: warning: ‘outvert’ may be used uninitialized [-Wmaybe-uninitialized]
347 | : Base(xpr.data() + i * ( ((BlockRows==1) && (BlockCols==XprType::ColsAtCompileTime) && (!XprTypeIsRowMajor))
| ~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
348 | || ((BlockRows==XprType::RowsAtCompileTime) && (BlockCols==1) && ( XprTypeIsRowMajor)) ? xpr.innerStride() : xpr.outerStride()),
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
include/convex_bodies/vpolytope.h: In function ‘void VPolytope<Point>::compute_reflection(Point&, const Point&, const int&) const [with Point = point<Cartesian<double> >]’:
include/convex_bodies/vpolytope.h:423:24: note: ‘outvert’ was declared here
423 | int count = 0, outvert;
| ^~~~~~~
g++ -std=gnu++17 -shared -L/usr/local/lib64 -o volesti.so RcppExports.o copula.o direct_sampling.o exact_vol.o frustum_of_simplex.o inner_ball.o load_sdpa_format_file.o poly_gen.o rotating.o rounding.o sample_points.o volume.o write_sdpa_format_file.o zonotope_approximation.o -Lexternal/lpsolve/build/lp_solve -llp_solve -llapack -L/data/gannet/ripley/R/R-devel/lib -lRblas -lgfortran -lm -lquadmath
make[1]: Leaving directory '/data/gannet/ripley/R/packages/tests-devel/volesti/src'
make[1]: Entering directory '/data/gannet/ripley/R/packages/tests-devel/volesti/src'
make[1]: Leaving directory '/data/gannet/ripley/R/packages/tests-devel/volesti/src'
installing to /data/gannet/ripley/R/packages/tests-devel/volesti.Rcheck/00LOCK-volesti/00new/volesti/libs
** R
** inst
** byte-compile and prepare package for lazy loading
** help
*** installing help indices
** building package indices
** testing if installed package can be loaded from temporary location
** checking absolute paths in shared objects and dynamic libraries
** testing if installed package can be loaded from final location
** testing if installed package keeps a record of temporary installation path
* DONE (volesti)