Hi folks,

For debugging purposes, I need to use the `distribute_local_to_global` 
function which can distribute vectors and matrices separately (this guy in 
the docs 
<https://dealii.org/current/doxygen/deal.II/classAffineConstraints.html#ae02ed5ba9f1be9c34cf448a01b44abdb>).
 
However, when I try to use this one instead of the function which 
simultaneously distributes a vector and a matrix (this guy in the docs 
<https://dealii.org/current/doxygen/deal.II/classAffineConstraints.html#abe83a7964b516856f5acb8046ec63a15>)
 
it throws an `error while loading shared libraries: libpetsc.so.3.16: 
cannot open shared object file: No such file or directory` error. 

For an example of the behavior, I just replaced the following on line 416 
of step-40:

// constraints.distribute_local_to_global(cell_matrix,
//                                                                     
cell_rhs,
 //                                                                    
local_dof_indices,
//                                                                    
system_matrix,
//                                                                    
system_rhs);
constraints.distribute_local_to_global(cell_matrix,
                                                                    
local_dof_indices,
                                                                    
system_matrix);
 constraints.distribute_local_to_global(cell_rhs,
                                                                     
local_dof_indices,
                                                                     
system_rhs);

This is sort of bizarre to me because (1) it doesn't throw the error in the 
original tutorial case and (2) CMake ought to take care of the PETSc 
dependency through the deal.II target. I've attached my detailed.log file 
in case it's relevant.

Any help figuring out the problem is appreciated!

- Lucas

-- 
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+unsubscr...@googlegroups.com.
To view this discussion on the web visit 
https://groups.google.com/d/msgid/dealii/fd85d887-5ab9-4875-bb4f-c918f9ffd739n%40googlegroups.com.
###
#
#  deal.II configuration:
#        CMAKE_BUILD_TYPE:       DebugRelease
#        BUILD_SHARED_LIBS:      ON
#        CMAKE_INSTALL_PREFIX:   /usr/local
#        CMAKE_SOURCE_DIR:       /home/lucas/Application-Data/dealii
#                                (version 10.0.0-pre, shortrev 24e77b90af)
#        CMAKE_BINARY_DIR:       /home/lucas/Application-Data/dealii/build
#        CMAKE_CXX_COMPILER:     GNU 9.3.0 on platform Linux x86_64
#                                /usr/bin/c++
#        C++ language standard:  C++14
#        CMAKE_C_COMPILER:       /usr/bin/cc
#        CMAKE_GENERATOR:        Unix Makefiles
#
#  Base configuration (prior to feature configuration):
#        DEAL_II_CXX_FLAGS:            -fPIC -Wall -Wextra -Wmissing-braces -Woverloaded-virtual -Wpointer-arith -Wsign-compare -Wsuggest-override -Wswitch -Wsynth -Wwrite-strings -Wno-placement-new -Wno-deprecated-declarations -Wno-literal-suffix -Wno-psabi -Wno-class-memaccess -fopenmp-simd
#        DEAL_II_CXX_FLAGS_RELEASE:    -O2 -funroll-loops -funroll-all-loops -fstrict-aliasing -Wno-unused-local-typedefs
#        DEAL_II_CXX_FLAGS_DEBUG:      -O0 -ggdb -Wa,--compress-debug-sections
#        DEAL_II_LINKER_FLAGS:         -Wl,--as-needed -rdynamic -fuse-ld=gold -lpthread -fopenmp
#        DEAL_II_LINKER_FLAGS_RELEASE: 
#        DEAL_II_LINKER_FLAGS_DEBUG:   -ggdb
#        DEAL_II_DEFINITIONS:          
#        DEAL_II_DEFINITIONS_RELEASE:  NDEBUG
#        DEAL_II_DEFINITIONS_DEBUG:    DEBUG
#        DEAL_II_USER_DEFINITIONS:     
#        DEAL_II_USER_DEFINITIONS_REL: NDEBUG
#        DEAL_II_USER_DEFINITIONS_DEB: DEBUG
#        DEAL_II_INCLUDE_DIRS          
#        DEAL_II_USER_INCLUDE_DIRS:    
#        DEAL_II_BUNDLED_INCLUDE_DIRS: 
#        DEAL_II_LIBRARIES:            
#        DEAL_II_LIBRARIES_RELEASE:    
#        DEAL_II_LIBRARIES_DEBUG:      
#        DEAL_II_VECTORIZATION_WIDTH_IN_BITS: 0
#        DEAL_II_HAVE_CXX14
#
#  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_ARBORX = OFF )
#      ( DEAL_II_WITH_ARPACK = OFF )
#      ( DEAL_II_WITH_ASSIMP = OFF )
#        DEAL_II_WITH_BOOST set up with external dependencies
#            BOOST_VERSION = 1.76.0
#            BOOST_CXX_FLAGS = -Wno-unused-local-typedefs
#            BOOST_DEFINITIONS = BOOST_NO_AUTO_PTR
#            BOOST_USER_DEFINITIONS = BOOST_NO_AUTO_PTR
#            BOOST_INCLUDE_DIRS = /usr/local/include
#            BOOST_USER_INCLUDE_DIRS = /usr/local/include
#            BOOST_LIBRARIES = /usr/local/lib/libboost_iostreams.so;/usr/local/lib/libboost_serialization.so;/usr/local/lib/libboost_system.so;/usr/local/lib/libboost_thread.so;/usr/local/lib/libboost_regex.so;/usr/local/lib/libboost_chrono.so;/usr/local/lib/libboost_date_time.so;/usr/local/lib/libboost_atomic.so
#        DEAL_II_WITH_COMPLEX_VALUES = ON
#        DEAL_II_WITH_CUDA set up with external dependencies
#            CUDA_VERSION = 11.4
#            CMAKE_CUDA_COMPILER = /usr/local/cuda-11.4/bin/nvcc
#            CUDA_COMPUTE_CAPABILITY = 7.5
#            DEAL_II_CUDA_FLAGS = -arch=sm_75
#            DEAL_II_CUDA_FLAGS_RELEASE = 
#            DEAL_II_CUDA_FLAGS_DEBUG = -G
#            CUDA_INCLUDE_DIRS = /usr/local/cuda-11.4/include
#            CUDA_USER_INCLUDE_DIRS = /usr/local/cuda-11.4/include
#            CUDA_LIBRARIES = /usr/local/cuda-11.4/lib64/libcudart.so;/usr/local/cuda-11.4/lib64/libcusparse.so;/usr/local/cuda-11.4/lib64/libcusolver.so
#      ( DEAL_II_WITH_GINKGO = OFF )
#      ( DEAL_II_WITH_GMSH = OFF )
#      ( DEAL_II_WITH_GSL = OFF )
#      ( DEAL_II_WITH_HDF5 = OFF )
#      ( DEAL_II_WITH_KOKKOS = OFF )
#        DEAL_II_WITH_LAPACK set up with external dependencies
#            LAPACK_WITH_64BIT_BLAS_INDICES = OFF
#            LAPACK_LINKER_FLAGS = 
#            LAPACK_INCLUDE_DIRS = 
#            LAPACK_USER_INCLUDE_DIRS = 
#            LAPACK_LIBRARIES = /usr/lib/x86_64-linux-gnu/liblapack.so;/usr/lib/x86_64-linux-gnu/libblas.so
#      ( DEAL_II_WITH_METIS = OFF )
#        DEAL_II_WITH_MPI set up with external dependencies
#            MPI_VERSION = 3.1
#            MPI_C_COMPILER = /usr/bin/mpicc
#            MPI_CXX_COMPILER = /usr/bin/mpicxx
#            MPI_CXX_FLAGS = -pthread
#            MPI_LINKER_FLAGS = -pthread
#            MPI_INCLUDE_DIRS = /usr/lib/x86_64-linux-gnu/openmpi/include/openmpi;/usr/lib/x86_64-linux-gnu/openmpi/include
#            MPI_USER_INCLUDE_DIRS = /usr/lib/x86_64-linux-gnu/openmpi/include/openmpi;/usr/lib/x86_64-linux-gnu/openmpi/include
#            MPI_LIBRARIES = /usr/lib/x86_64-linux-gnu/openmpi/lib/libmpi_cxx.so;/usr/lib/x86_64-linux-gnu/openmpi/lib/libmpi.so;/usr/lib/x86_64-linux-gnu/openmpi/lib/libopen-pal.so
#        DEAL_II_WITH_MUPARSER set up with bundled packages
#            MUPARSER_BUNDLED_INCLUDE_DIRS = /home/lucas/Application-Data/dealii/bundled/muparser_v2_2_4//include
#      ( DEAL_II_WITH_OPENCASCADE = OFF )
#        DEAL_II_WITH_P4EST set up with external dependencies
#            P4EST_VERSION = 2.8
#            P4EST_DIR = /home/lucas/Application-Data/p4est
#            P4EST_INCLUDE_DIRS = /home/lucas/Application-Data/p4est/FAST/include
#            P4EST_USER_INCLUDE_DIRS = /home/lucas/Application-Data/p4est/FAST/include
#            P4EST_LIBRARIES = optimized;/home/lucas/Application-Data/p4est/FAST/lib/libp4est.so;/home/lucas/Application-Data/p4est/FAST/lib/libsc.so;debug;/home/lucas/Application-Data/p4est/DEBUG/lib/libp4est.so;/home/lucas/Application-Data/p4est/DEBUG/lib/libsc.so;general;/usr/lib/x86_64-linux-gnu/liblapack.so;/usr/lib/x86_64-linux-gnu/libblas.so;/usr/lib/x86_64-linux-gnu/openmpi/lib/libmpi.so
#        DEAL_II_WITH_PETSC set up with external dependencies
#            PETSC_VERSION = 3.16.3.0
#            PETSC_DIR = /home/lucas/Application-Data/petsc
#            PETSC_INCLUDE_DIRS = /home/lucas/Application-Data/petsc/include;/home/lucas/Application-Data/petsc/x86_64/include
#            PETSC_USER_INCLUDE_DIRS = /home/lucas/Application-Data/petsc/include;/home/lucas/Application-Data/petsc/x86_64/include
#            PETSC_LIBRARIES = /home/lucas/Application-Data/petsc/x86_64/lib/libpetsc.so;/home/lucas/Application-Data/petsc/x86_64/lib/libHYPRE.so;/usr/lib/x86_64-linux-gnu/liblapack.so;/usr/lib/x86_64-linux-gnu/libblas.so;/usr/lib/x86_64-linux-gnu/libX11.so;/usr/lib/x86_64-linux-gnu/openmpi/lib/libmpi_usempif08.so;/usr/lib/x86_64-linux-gnu/openmpi/lib/libmpi_usempi_ignore_tkr.so;/usr/lib/x86_64-linux-gnu/openmpi/lib/libmpi_mpifh.so;/usr/lib/x86_64-linux-gnu/openmpi/lib/libmpi.so;gfortran;m;quadmath;dl
#      ( DEAL_II_WITH_SCALAPACK = OFF )
#      ( DEAL_II_WITH_SLEPC = OFF )
#      ( DEAL_II_WITH_SUNDIALS = OFF )
#      ( DEAL_II_WITH_SYMENGINE = OFF )
#        DEAL_II_WITH_TASKFLOW set up with bundled packages
#            TASKFLOW_BUNDLED_INCLUDE_DIRS = /home/lucas/Application-Data/dealii/bundled/taskflow-2.5.0/include
#        DEAL_II_WITH_TBB set up with bundled packages
#            TBB_CXX_FLAGS = -Wno-parentheses
#            TBB_BUNDLED_INCLUDE_DIRS = /home/lucas/Application-Data/dealii/bundled/tbb-2018_U2/include
#            TBB_LIBRARIES = dl
#      ( DEAL_II_WITH_TRILINOS = OFF )
#        DEAL_II_WITH_UMFPACK set up with bundled packages
#            UMFPACK_BUNDLED_INCLUDE_DIRS = /home/lucas/Application-Data/dealii/bundled/umfpack/UMFPACK/Include;/home/lucas/Application-Data/dealii/bundled/umfpack/AMD/Include
#        DEAL_II_WITH_ZLIB set up with external dependencies
#            ZLIB_VERSION = 1.2.11
#            ZLIB_INCLUDE_DIRS = /usr/include
#            ZLIB_LIBRARIES = /usr/lib/x86_64-linux-gnu/libz.so
#
#  Component configuration:
#      ( DEAL_II_COMPONENT_DOCUMENTATION = OFF )
#        DEAL_II_COMPONENT_EXAMPLES
#      ( DEAL_II_COMPONENT_PACKAGE = OFF )
#      ( DEAL_II_COMPONENT_PYTHON_BINDINGS = OFF )
#
###

Reply via email to