Compile error with function compute_bounding_box on GCC 8.5

25 views
Skip to first unread message

Reza Rastak

unread,
Feb 28, 2019, 9:39:18 PM2/28/19
to deal.II User Group
Hi,

I tried to compile the master branch (commit f5375c1) on my system without any MPI or Trilinos or other dependencies. I received an error when compiling the function compute_bounding_box inside source/grid/grid_tools_cache.cc. It complains that IteratorFilters::LocallyOwnedCell is not derived from std::function<bool(active_cell_iterator&)>. There is no compilation error with the stable branch "dealii-9.0". Should I raise this issue on Github repo?

Thank you,

Reza Rastak


** Build config:

dealii/build$ cat revision.log 
###
#
#  Git information:
#        Branch:   master
#        Revision: f5375c10e7b1731ee1d38a0d7a8c7b0a5f7f82a7
#
###

dealii/build$ cat summary.log 
###
#
#  deal.II configuration:
#        CMAKE_BUILD_TYPE:       DebugRelease
#        BUILD_SHARED_LIBS:      ON
#        CMAKE_INSTALL_PREFIX:   /usr/local
#        CMAKE_SOURCE_DIR:       /mnt/scratch/repos/dealii
#                                (version 9.1.0-pre, shortrev f5375c1)
#        CMAKE_BINARY_DIR:       /mnt/scratch/repos/dealii/build
#        CMAKE_CXX_COMPILER:     GNU 4.8.5 on platform Linux x86_64
#                                /usr/bin/c++
#
#  Configured Features (DEAL_II_ALLOW_BUNDLED = ON, DEAL_II_ALLOW_AUTODETECTION = ON):
#      ( DEAL_II_WITH_64BIT_INDICES = OFF )
#      ( DEAL_II_WITH_ADOLC = OFF )
#      ( DEAL_II_WITH_ARPACK = OFF )
#      ( DEAL_II_WITH_ASSIMP = OFF )
#        DEAL_II_WITH_BOOST set up with bundled packages
#        DEAL_II_WITH_COMPLEX_VALUES = ON
#      ( DEAL_II_WITH_CUDA = OFF )
#      ( DEAL_II_WITH_CUDA_AWARE_MPI = OFF )
#      ( DEAL_II_WITH_CXX14 = OFF )
#      ( DEAL_II_WITH_CXX17 = OFF )
#      ( DEAL_II_WITH_GINKGO = OFF )
#        DEAL_II_WITH_GMSH set up with external dependencies
#      ( DEAL_II_WITH_GSL = OFF )
#      ( DEAL_II_WITH_HDF5 = OFF )
#        DEAL_II_WITH_LAPACK set up with external dependencies
#      ( DEAL_II_WITH_METIS = OFF )
#      ( DEAL_II_WITH_MPI = OFF )
#        DEAL_II_WITH_MUPARSER set up with bundled packages
#      ( DEAL_II_WITH_NANOFLANN = OFF )
#      ( DEAL_II_WITH_NETCDF = OFF )
#      ( DEAL_II_WITH_OPENCASCADE = OFF )
#      ( DEAL_II_WITH_P4EST = OFF )
#      ( DEAL_II_WITH_PETSC = OFF )
#      ( DEAL_II_WITH_SCALAPACK = OFF )
#      ( DEAL_II_WITH_SLEPC = OFF )
#      ( DEAL_II_WITH_SUNDIALS = OFF )
#        DEAL_II_WITH_THREADS set up with external dependencies
#      ( DEAL_II_WITH_TRILINOS = OFF )
#        DEAL_II_WITH_UMFPACK set up with external dependencies
#        DEAL_II_WITH_ZLIB set up with external dependencies
#
#  Component configuration:
#      ( DEAL_II_COMPONENT_DOCUMENTATION = OFF )
#        DEAL_II_COMPONENT_EXAMPLES
#      ( DEAL_II_COMPONENT_PACKAGE = OFF )
#      ( DEAL_II_COMPONENT_PYTHON_BINDINGS = OFF )
#
#  Detailed information (compiler flags, feature configuration) can be found in detailed.log
#
#  Run  $ make info  to print a help message with a list of top level targets
#
#############################################################################


Make command:
dealii/build$ make obj_grid_debug
Scanning dependencies of target expand_instantiations_exe
Building CXX object cmake/scripts/CMakeFiles/expand_instantiations_exe.dir/expand_instantiations.cc.o
Linking CXX executable ../../bin/expand_instantiations
Built target expand_instantiations_exe
Scanning dependencies of target obj_grid_inst
Generating cell_id.inst
Generating grid_generator.inst
Generating grid_in.inst
Generating grid_out.inst
Generating grid_refinement.inst
Generating grid_tools.inst
Generating grid_tools_dof_handlers.inst
Generating grid_tools_cache.inst
Generating intergrid_map.inst
Generating manifold.inst
Generating manifold_lib.inst
Generating tria_accessor.inst
Generating tria.inst
Generating tria_objects.inst
Built target obj_grid_inst
Scanning dependencies of target obj_grid_debug
Building CXX object source/grid/CMakeFiles/obj_grid_debug.dir/cell_id.cc.o
Building CXX object source/grid/CMakeFiles/obj_grid_debug.dir/grid_generator.cc.o
Building CXX object source/grid/CMakeFiles/obj_grid_debug.dir/grid_in.cc.o
Building CXX object source/grid/CMakeFiles/obj_grid_debug.dir/grid_out.cc.o
Building CXX object source/grid/CMakeFiles/obj_grid_debug.dir/grid_refinement.cc.o
Building CXX object source/grid/CMakeFiles/obj_grid_debug.dir/grid_tools_cache.cc.o
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc: In instantiation of ‘dealii::RTree<std::pair<dealii::BoundingBox<spacedim>, unsigned int> >& dealii::GridTools::Cache<dim, spacedim>::get_covering_rtree() const [with int dim = 1; int spacedim = 1; dealii::RTree<std::pair<dealii::BoundingBox<spacedim>, unsigned int> > = boost::geometry::index::rtree<std::pair<dealii::BoundingBox<1, double>, unsigned int>, boost::geometry::index::linear<16ul>, boost::geometry::index::indexable<std::pair<dealii::BoundingBox<1, double>, unsigned int> >, boost::geometry::index::equal_to<std::pair<dealii::BoundingBox<1, double>, unsigned int> >, std::allocator<std::pair<dealii::BoundingBox<1, double>, unsigned int> > >]’:
/mnt/scratch/repos/dealii/build/source/grid/grid_tools_cache.inst:11:17:   required from here
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: error: no matching function for call to ‘compute_bounding_box(const dealii::Triangulation<1, 1>&, dealii::IteratorFilters::LocallyOwnedCell&)’
           GridTools::compute_bounding_box(*tria, locally_owned_cell_predicate);
                                                                              ^
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note: candidates are:
In file included from /mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:20:0:
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:244:3: note: template<int dim, int spacedim> dealii::BoundingBox<spacedim> dealii::GridTools::compute_bounding_box(const dealii::Triangulation<dim, spacedim>&)
   compute_bounding_box(const Triangulation<dim, spacedim> &triangulation);
   ^
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:244:3: note:   template argument deduction/substitution failed:
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note:   candidate expects 1 argument, 2 provided
           GridTools::compute_bounding_box(*tria, locally_owned_cell_predicate);
                                                                              ^
In file included from /mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:20:0:
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:1535:3: note: template<class MeshType> std::pair<dealii::Point<MeshType:: space_dimension>, dealii::Point<MeshType:: space_dimension> > dealii::GridTools::compute_bounding_box(const MeshType&, const std::function<bool(const typename MeshType::active_cell_iterator&)>&)
   compute_bounding_box(
   ^
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:1535:3: note:   template argument deduction/substitution failed:
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note:   ‘dealii::IteratorFilters::LocallyOwnedCell’ is not derived from ‘const std::function<bool(const typename MeshType::active_cell_iterator&)>’
           GridTools::compute_bounding_box(*tria, locally_owned_cell_predicate);
                                                                              ^
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc: In instantiation of ‘dealii::RTree<std::pair<dealii::BoundingBox<spacedim>, unsigned int> >& dealii::GridTools::Cache<dim, spacedim>::get_covering_rtree() const [with int dim = 1; int spacedim = 2; dealii::RTree<std::pair<dealii::BoundingBox<spacedim>, unsigned int> > = boost::geometry::index::rtree<std::pair<dealii::BoundingBox<2, double>, unsigned int>, boost::geometry::index::linear<16ul>, boost::geometry::index::indexable<std::pair<dealii::BoundingBox<2, double>, unsigned int> >, boost::geometry::index::equal_to<std::pair<dealii::BoundingBox<2, double>, unsigned int> >, std::allocator<std::pair<dealii::BoundingBox<2, double>, unsigned int> > >]’:
/mnt/scratch/repos/dealii/build/source/grid/grid_tools_cache.inst:17:17:   required from here
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: error: no matching function for call to ‘compute_bounding_box(const dealii::Triangulation<1, 2>&, dealii::IteratorFilters::LocallyOwnedCell&)’
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note: candidates are:
In file included from /mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:20:0:
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:244:3: note: template<int dim, int spacedim> dealii::BoundingBox<spacedim> dealii::GridTools::compute_bounding_box(const dealii::Triangulation<dim, spacedim>&)
   compute_bounding_box(const Triangulation<dim, spacedim> &triangulation);
   ^
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:244:3: note:   template argument deduction/substitution failed:
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note:   candidate expects 1 argument, 2 provided
           GridTools::compute_bounding_box(*tria, locally_owned_cell_predicate);
                                                                              ^
In file included from /mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:20:0:
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:1535:3: note: template<class MeshType> std::pair<dealii::Point<MeshType:: space_dimension>, dealii::Point<MeshType:: space_dimension> > dealii::GridTools::compute_bounding_box(const MeshType&, const std::function<bool(const typename MeshType::active_cell_iterator&)>&)
   compute_bounding_box(
   ^
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:1535:3: note:   template argument deduction/substitution failed:
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note:   ‘dealii::IteratorFilters::LocallyOwnedCell’ is not derived from ‘const std::function<bool(const typename MeshType::active_cell_iterator&)>’
           GridTools::compute_bounding_box(*tria, locally_owned_cell_predicate);
                                                                              ^
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc: In instantiation of ‘dealii::RTree<std::pair<dealii::BoundingBox<spacedim>, unsigned int> >& dealii::GridTools::Cache<dim, spacedim>::get_covering_rtree() const [with int dim = 1; int spacedim = 3; dealii::RTree<std::pair<dealii::BoundingBox<spacedim>, unsigned int> > = boost::geometry::index::rtree<std::pair<dealii::BoundingBox<3, double>, unsigned int>, boost::geometry::index::linear<16ul>, boost::geometry::index::indexable<std::pair<dealii::BoundingBox<3, double>, unsigned int> >, boost::geometry::index::equal_to<std::pair<dealii::BoundingBox<3, double>, unsigned int> >, std::allocator<std::pair<dealii::BoundingBox<3, double>, unsigned int> > >]’:
/mnt/scratch/repos/dealii/build/source/grid/grid_tools_cache.inst:23:17:   required from here
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: error: no matching function for call to ‘compute_bounding_box(const dealii::Triangulation<1, 3>&, dealii::IteratorFilters::LocallyOwnedCell&)’
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note: candidates are:
In file included from /mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:20:0:
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:244:3: note: template<int dim, int spacedim> dealii::BoundingBox<spacedim> dealii::GridTools::compute_bounding_box(const dealii::Triangulation<dim, spacedim>&)
   compute_bounding_box(const Triangulation<dim, spacedim> &triangulation);
   ^
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:244:3: note:   template argument deduction/substitution failed:
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note:   candidate expects 1 argument, 2 provided
           GridTools::compute_bounding_box(*tria, locally_owned_cell_predicate);
                                                                              ^
In file included from /mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:20:0:
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:1535:3: note: template<class MeshType> std::pair<dealii::Point<MeshType:: space_dimension>, dealii::Point<MeshType:: space_dimension> > dealii::GridTools::compute_bounding_box(const MeshType&, const std::function<bool(const typename MeshType::active_cell_iterator&)>&)
   compute_bounding_box(
   ^
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:1535:3: note:   template argument deduction/substitution failed:
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note:   ‘dealii::IteratorFilters::LocallyOwnedCell’ is not derived from ‘const std::function<bool(const typename MeshType::active_cell_iterator&)>’
           GridTools::compute_bounding_box(*tria, locally_owned_cell_predicate);
                                                                              ^
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc: In instantiation of ‘dealii::RTree<std::pair<dealii::BoundingBox<spacedim>, unsigned int> >& dealii::GridTools::Cache<dim, spacedim>::get_covering_rtree() const [with int dim = 2; int spacedim = 2; dealii::RTree<std::pair<dealii::BoundingBox<spacedim>, unsigned int> > = boost::geometry::index::rtree<std::pair<dealii::BoundingBox<2, double>, unsigned int>, boost::geometry::index::linear<16ul>, boost::geometry::index::indexable<std::pair<dealii::BoundingBox<2, double>, unsigned int> >, boost::geometry::index::equal_to<std::pair<dealii::BoundingBox<2, double>, unsigned int> >, std::allocator<std::pair<dealii::BoundingBox<2, double>, unsigned int> > >]’:
/mnt/scratch/repos/dealii/build/source/grid/grid_tools_cache.inst:35:17:   required from here
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: error: no matching function for call to ‘compute_bounding_box(const dealii::Triangulation<2, 2>&, dealii::IteratorFilters::LocallyOwnedCell&)’
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note: candidates are:
In file included from /mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:20:0:
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:244:3: note: template<int dim, int spacedim> dealii::BoundingBox<spacedim> dealii::GridTools::compute_bounding_box(const dealii::Triangulation<dim, spacedim>&)
   compute_bounding_box(const Triangulation<dim, spacedim> &triangulation);
   ^
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:244:3: note:   template argument deduction/substitution failed:
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note:   candidate expects 1 argument, 2 provided
           GridTools::compute_bounding_box(*tria, locally_owned_cell_predicate);
                                                                              ^
In file included from /mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:20:0:
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:1535:3: note: template<class MeshType> std::pair<dealii::Point<MeshType:: space_dimension>, dealii::Point<MeshType:: space_dimension> > dealii::GridTools::compute_bounding_box(const MeshType&, const std::function<bool(const typename MeshType::active_cell_iterator&)>&)
   compute_bounding_box(
   ^
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:1535:3: note:   template argument deduction/substitution failed:
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note:   ‘dealii::IteratorFilters::LocallyOwnedCell’ is not derived from ‘const std::function<bool(const typename MeshType::active_cell_iterator&)>’
           GridTools::compute_bounding_box(*tria, locally_owned_cell_predicate);
                                                                              ^
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc: In instantiation of ‘dealii::RTree<std::pair<dealii::BoundingBox<spacedim>, unsigned int> >& dealii::GridTools::Cache<dim, spacedim>::get_covering_rtree() const [with int dim = 2; int spacedim = 3; dealii::RTree<std::pair<dealii::BoundingBox<spacedim>, unsigned int> > = boost::geometry::index::rtree<std::pair<dealii::BoundingBox<3, double>, unsigned int>, boost::geometry::index::linear<16ul>, boost::geometry::index::indexable<std::pair<dealii::BoundingBox<3, double>, unsigned int> >, boost::geometry::index::equal_to<std::pair<dealii::BoundingBox<3, double>, unsigned int> >, std::allocator<std::pair<dealii::BoundingBox<3, double>, unsigned int> > >]’:
/mnt/scratch/repos/dealii/build/source/grid/grid_tools_cache.inst:41:17:   required from here
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: error: no matching function for call to ‘compute_bounding_box(const dealii::Triangulation<2, 3>&, dealii::IteratorFilters::LocallyOwnedCell&)’
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note: candidates are:
In file included from /mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:20:0:
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:244:3: note: template<int dim, int spacedim> dealii::BoundingBox<spacedim> dealii::GridTools::compute_bounding_box(const dealii::Triangulation<dim, spacedim>&)
   compute_bounding_box(const Triangulation<dim, spacedim> &triangulation);
   ^
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:244:3: note:   template argument deduction/substitution failed:
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note:   candidate expects 1 argument, 2 provided
           GridTools::compute_bounding_box(*tria, locally_owned_cell_predicate);
                                                                              ^
In file included from /mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:20:0:
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:1535:3: note: template<class MeshType> std::pair<dealii::Point<MeshType:: space_dimension>, dealii::Point<MeshType:: space_dimension> > dealii::GridTools::compute_bounding_box(const MeshType&, const std::function<bool(const typename MeshType::active_cell_iterator&)>&)
   compute_bounding_box(
   ^
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:1535:3: note:   template argument deduction/substitution failed:
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note:   ‘dealii::IteratorFilters::LocallyOwnedCell’ is not derived from ‘const std::function<bool(const typename MeshType::active_cell_iterator&)>’
           GridTools::compute_bounding_box(*tria, locally_owned_cell_predicate);
                                                                              ^
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc: In instantiation of ‘dealii::RTree<std::pair<dealii::BoundingBox<spacedim>, unsigned int> >& dealii::GridTools::Cache<dim, spacedim>::get_covering_rtree() const [with int dim = 3; int spacedim = 3; dealii::RTree<std::pair<dealii::BoundingBox<spacedim>, unsigned int> > = boost::geometry::index::rtree<std::pair<dealii::BoundingBox<3, double>, unsigned int>, boost::geometry::index::linear<16ul>, boost::geometry::index::indexable<std::pair<dealii::BoundingBox<3, double>, unsigned int> >, boost::geometry::index::equal_to<std::pair<dealii::BoundingBox<3, double>, unsigned int> >, std::allocator<std::pair<dealii::BoundingBox<3, double>, unsigned int> > >]’:
/mnt/scratch/repos/dealii/build/source/grid/grid_tools_cache.inst:59:17:   required from here
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: error: no matching function for call to ‘compute_bounding_box(const dealii::Triangulation<3, 3>&, dealii::IteratorFilters::LocallyOwnedCell&)’
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note: candidates are:
In file included from /mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:20:0:
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:244:3: note: template<int dim, int spacedim> dealii::BoundingBox<spacedim> dealii::GridTools::compute_bounding_box(const dealii::Triangulation<dim, spacedim>&)
   compute_bounding_box(const Triangulation<dim, spacedim> &triangulation);
   ^
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:244:3: note:   template argument deduction/substitution failed:
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note:   candidate expects 1 argument, 2 provided
           GridTools::compute_bounding_box(*tria, locally_owned_cell_predicate);
                                                                              ^
In file included from /mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:20:0:
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:1535:3: note: template<class MeshType> std::pair<dealii::Point<MeshType:: space_dimension>, dealii::Point<MeshType:: space_dimension> > dealii::GridTools::compute_bounding_box(const MeshType&, const std::function<bool(const typename MeshType::active_cell_iterator&)>&)
   compute_bounding_box(
   ^
/mnt/scratch/repos/dealii/include/deal.II/grid/grid_tools.h:1535:3: note:   template argument deduction/substitution failed:
/mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc:172:78: note:   ‘dealii::IteratorFilters::LocallyOwnedCell’ is not derived from ‘const std::function<bool(const typename MeshType::active_cell_iterator&)>’
           GridTools::compute_bounding_box(*tria, locally_owned_cell_predicate);
                                                                              ^
make[3]: *** [source/grid/CMakeFiles/obj_grid_debug.dir/grid_tools_cache.cc.o] Error 1
make[2]: *** [source/grid/CMakeFiles/obj_grid_debug.dir/all] Error 2
make[1]: *** [source/grid/CMakeFiles/obj_grid_debug.dir/rule] Error 2
make: *** [obj_grid_debug] Error 2

#######################################################################
Compilation command (taken from make VERBOSE=on obj_grid_debug)

cd /mnt/scratch/repos/dealii/build/source/grid && /usr/bin/c++   -DDEBUG -I/mnt/scratch/repos/dealii/build/source/grid -I/mnt/scratch/repos/dealii/build/include -I/mnt/scratch/repos/dealii/include -I/mnt/scratch/repos/dealii/bundled/boost-1.62.0/include -I/mnt/scratch/repos/dealii/bundled/muparser_v2_2_4/include -isystem /usr/include/suitesparse    -pedantic -fPIC -Wall -Wextra -Woverloaded-virtual -Wpointer-arith -Wsign-compare -Wswitch -Wsynth -Wwrite-strings -Wno-deprecated-declarations -Wno-literal-suffix -Wno-psabi -std=c++11 -Wno-unused-local-typedefs -O0 -ggdb -Wa,--compress-debug-sections -o CMakeFiles/obj_grid_debug.dir/grid_tools_cache.cc.o -c /mnt/scratch/repos/dealii/source/grid/grid_tools_cache.cc





Reza Rastak

unread,
Feb 28, 2019, 9:44:23 PM2/28/19
to deal.II User Group
I apologize because of typo in the subject line. Version is GCC 4.8.5

Reza

Jean-Paul Pelteret

unread,
Mar 1, 2019, 4:46:22 AM3/1/19
to dea...@googlegroups.com
Hi Reza,

Thanks for letting us know about this problem. Yes, its best to report these types of issues directly on the GitHub repository :-) I’ve opened an issue based on the details that you given. You can track it here:

It looks like our testers run GCC 4.9.4 and above, which is probably why we haven’t encountered this problem before. I’m not sure what the best fix for this should be, since I don’t see any reason as to why this problem should have arisen in the first place. But hopefully your report will lead to a discussion about this and a quick fix.

Thanks again!
Best,
Jean-Paul

--
The deal.II project is located at http://www.dealii.org/
For mailing list/forum options, see https://groups.google.com/d/forum/dealii?hl=en
---
You received this message because you are subscribed to the Google Groups "deal.II User Group" group.
To unsubscribe from this group and stop receiving emails from it, send an email to dealii+un...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.

Reply all
Reply to author
Forward
0 new messages