From 2782edd6acff1831820e0e36157ec46a7b73a90d Mon Sep 17 00:00:00 2001 From: Daniel Arndt Date: Tue, 6 Aug 2024 17:03:09 -0400 Subject: [PATCH] Remove 9.5 release deprecations --- doc/news/changes/20240807DanielArndt | 4 + include/deal.II/base/array_view.h | 131 ------------------ include/deal.II/base/data_out_base.h | 66 --------- include/deal.II/base/mpi.h | 39 ------ include/deal.II/base/mpi_tags.h | 1 - include/deal.II/base/symmetric_tensor.h | 85 ------------ include/deal.II/base/tensor.h | 24 ---- .../distributed/fully_distributed_tria.h | 11 +- include/deal.II/distributed/tria.h | 27 ---- include/deal.II/distributed/tria_base.h | 10 -- include/deal.II/dofs/dof_handler.h | 24 ---- include/deal.II/fe/mapping_q.h | 9 -- include/deal.II/grid/grid_tools.h | 21 --- .../lac/slepc_spectral_transformation.h | 45 ------ include/deal.II/particles/particle_accessor.h | 30 ---- include/deal.II/particles/particle_handler.h | 28 ---- include/deal.II/physics/transformations.h | 20 --- source/base/data_out_base.cc | 58 -------- source/base/mpi.cc | 13 -- source/distributed/fully_distributed_tria.cc | 11 -- source/distributed/tria.cc | 20 --- source/fe/mapping_q.cc | 7 - source/grid/grid_tools.cc | 15 -- source/grid/grid_tools.inst.in | 6 - source/lac/slepc_spectral_transformation.cc | 21 --- source/particles/particle_handler.cc | 19 --- tests/mpi/create_group_01.cc | 59 -------- tests/mpi/create_group_01.mpirun=3.output | 8 -- tests/mpi/data_out_hdf5_02.cc | 3 +- tests/mpi/p4est_save_01.cc | 2 +- tests/mpi/p4est_save_02.cc | 2 +- tests/mpi/p4est_save_03.cc | 2 +- tests/particles/step-19.cc | 4 +- tests/tensors/tensor.cc | 2 +- tests/tensors/tensor_complex.cc | 2 +- tests/tensors/tensor_float.cc | 2 +- 36 files changed, 16 insertions(+), 815 deletions(-) create mode 100644 doc/news/changes/20240807DanielArndt delete mode 100644 tests/mpi/create_group_01.cc delete mode 100644 tests/mpi/create_group_01.mpirun=3.output diff --git a/doc/news/changes/20240807DanielArndt b/doc/news/changes/20240807DanielArndt new file mode 100644 index 0000000000..467bc3528c --- /dev/null +++ b/doc/news/changes/20240807DanielArndt @@ -0,0 +1,4 @@ +Removed: Deprecations from the 9.5 release have been removed. +See https://github.com/dealii/dealii/pull/17444 for details. +
+(Daniel Arndt, 2024/08/07) diff --git a/include/deal.II/base/array_view.h b/include/deal.II/base/array_view.h index dcfcd17e57..213382e17f 100644 --- a/include/deal.II/base/array_view.h +++ b/include/deal.II/base/array_view.h @@ -1030,137 +1030,6 @@ make_array_view(ArrayView &array_view) -/** - * Create a view to an entire Tensor object. This is equivalent to initializing - * an ArrayView object with a pointer to the first element and the size of the - * given argument. - * - * This function is used for @p const references to objects of Tensor type - * because they contain immutable elements. Consequently, the return type of - * this function is a view to a set of @p const objects. - * - * @param[in] tensor The Tensor for which we want to have an array view - * object. The array view corresponds to the entire object but the - * order in which the entries are presented in the array is an implementation - * detail and should not be relied upon. - * - * @deprecated This function suggests that the elements of a Tensor - * object are stored as a contiguous array, but this is not in fact true - * and one should not pretend that this so. As a consequence, this function - * is deprecated. - * - * @relatesalso ArrayView - */ -template -DEAL_II_DEPRECATED inline ArrayView -make_array_view(const Tensor &tensor) -{ - static_assert(rank == 1, - "This function is only available for rank-1 tensors " - "because higher-rank tensors may not store their elements " - "in a contiguous array."); - - return make_array_view(tensor.begin_raw(), tensor.end_raw()); -} - - - -/** - * Create a view to an entire Tensor object. This is equivalent to initializing - * an ArrayView object with a pointer to the first element and the size of the - * given argument. - * - * This function is used for non-@p const references to objects of Tensor type. - * Such objects contain elements that can be written to. Consequently, - * the return type of this function is a view to a set of writable objects. - * - * @param[in] tensor The Tensor for which we want to have an array view - * object. The array view corresponds to the entire object but the - * order in which the entries are presented in the array is an implementation - * detail and should not be relied upon. - * - * @deprecated This function suggests that the elements of a Tensor - * object are stored as a contiguous array, but this is not in fact true - * and one should not pretend that this so. As a consequence, this function - * is deprecated. - * - * @relatesalso ArrayView - */ -template -DEAL_II_DEPRECATED inline ArrayView -make_array_view(Tensor &tensor) -{ - static_assert(rank == 1, - "This function is only available for rank-1 tensors " - "because higher-rank tensors may not store their elements " - "in a contiguous array."); - - return make_array_view(tensor.begin_raw(), tensor.end_raw()); -} - - - -/** - * Create a view to an entire SymmetricTensor object. This is equivalent to - * initializing an ArrayView object with a pointer to the first element and the - * size of the given argument. - * - * This function is used for @p const references to objects of SymmetricTensor - * type because they contain immutable elements. Consequently, the return type - * of this function is a view to a set of @p const objects. - * - * @param[in] tensor The SymmetricTensor for which we want to have an array - * view object. The array view corresponds to the entire object but - * the order in which the entries are presented in the array is an - * implementation detail and should not be relied upon. - * - * @deprecated This function suggests that the elements of a SymmetricTensor - * object are stored as a contiguous array, but this is not in fact true - * and one should not pretend that this so. As a consequence, this function - * is deprecated. - * - * @relatesalso ArrayView - */ -template -DEAL_II_DEPRECATED inline ArrayView -make_array_view(const SymmetricTensor &tensor) -{ - return make_array_view(tensor.begin_raw(), tensor.end_raw()); -} - - - -/** - * Create a view to an entire SymmetricTensor object. This is equivalent to - * initializing an ArrayView object with a pointer to the first element and the - * size of the given argument. - * - * This function is used for non-@p const references to objects of - * SymmetricTensor type. Such objects contain elements that can be written to. - * Consequently, the return type of this function is a view to a set of writable - * objects. - * - * @param[in] tensor The SymmetricTensor for which we want to have an array - * view object. The array view corresponds to the entire object but - * the order in which the entries are presented in the array is an - * implementation detail and should not be relied upon. - * - * @deprecated This function suggests that the elements of a SymmetricTensor - * object are stored as a contiguous array, but this is not in fact true - * and one should not pretend that this so. As a consequence, this function - * is deprecated. - * - * @relatesalso ArrayView - */ -template -DEAL_II_DEPRECATED inline ArrayView -make_array_view(SymmetricTensor &tensor) -{ - return make_array_view(tensor.begin_raw(), tensor.end_raw()); -} - - - /** * Create a view to an entire C-style array. This is equivalent to * initializing an ArrayView object with a pointer to the first element and diff --git a/include/deal.II/base/data_out_base.h b/include/deal.II/base/data_out_base.h index daaa77d13c..a9c8c0cb3b 100644 --- a/include/deal.II/base/data_out_base.h +++ b/include/deal.II/base/data_out_base.h @@ -1157,24 +1157,6 @@ namespace DataOutBase */ bool print_date_and_time; - /** - * A data type providing the different possible zlib compression - * levels. These map directly to constants defined by zlib. - * - * @deprecated Use DataOutBase::CompressionLevel instead. - */ - using ZlibCompressionLevel DEAL_II_DEPRECATED = - DataOutBase::CompressionLevel; - - DEAL_II_DEPRECATED static const DataOutBase::CompressionLevel - no_compression = DataOutBase::CompressionLevel::no_compression; - DEAL_II_DEPRECATED static const DataOutBase::CompressionLevel - best_compression = DataOutBase::CompressionLevel::best_compression; - DEAL_II_DEPRECATED static const DataOutBase::CompressionLevel best_speed = - DataOutBase::CompressionLevel::best_speed; - DEAL_II_DEPRECATED static const DataOutBase::CompressionLevel - default_compression = DataOutBase::CompressionLevel::default_compression; - /** * Flag determining the compression level at which zlib, if available, is * run. The default is best_speed. @@ -3402,29 +3384,6 @@ public: const unsigned int dim, const ReferenceCell &cell_type); - /** - * Deprecated constructor. - * - * @deprecated Use the constructor that additionally takes a ReferenceCell. - */ - XDMFEntry(const std::string &filename, - const double time, - const std::uint64_t nodes, - const std::uint64_t cells, - const unsigned int dim); - - /** - * Deprecated constructor. - * - * @deprecated Use the constructor that additionally takes a ReferenceCell. - */ - XDMFEntry(const std::string &mesh_filename, - const std::string &solution_filename, - const double time, - const std::uint64_t nodes, - const std::uint64_t cells, - const unsigned int dim); - /** * Simplified constructor that calls the complete constructor for * cases where dim==spacedim. @@ -3437,20 +3396,6 @@ public: const unsigned int dim, const ReferenceCell &cell_type); - /** - * Deprecated constructor. - * - * @deprecated Use the constructor that additionally takes a ReferenceCell. - */ - DEAL_II_DEPRECATED - XDMFEntry(const std::string &mesh_filename, - const std::string &solution_filename, - const double time, - const std::uint64_t nodes, - const std::uint64_t cells, - const unsigned int dim, - const unsigned int spacedim); - /** * Constructor that sets all members to provided parameters. */ @@ -3489,17 +3434,6 @@ public: std::string get_xdmf_content(const unsigned int indent_level) const; - /** - * Get the XDMF content associated with this entry. - * If the entry is not valid, this returns an empty string. - * - * @deprecated Use the other function instead. - */ - DEAL_II_DEPRECATED - std::string - get_xdmf_content(const unsigned int indent_level, - const ReferenceCell &reference_cell) const; - private: /** * Whether this entry is valid and contains data to be written. diff --git a/include/deal.II/base/mpi.h b/include/deal.II/base/mpi.h index 69fc7be7d2..54869d3bd8 100644 --- a/include/deal.II/base/mpi.h +++ b/include/deal.II/base/mpi.h @@ -537,45 +537,6 @@ namespace Utilities bool get_was_called; }; - - - /** - * If @p comm is an intracommunicator, this function returns a new - * communicator @p newcomm with communication group defined by the - * @p group argument. The function is only collective over the group of - * processes that actually want to create the communicator, i.e., that - * are named in the @p group argument. If multiple threads at a given - * process perform concurrent create_group() operations, the user must - * distinguish these operations by providing different @p tag or @p comm - * arguments. - * - * This function was introduced in the MPI-3.0 standard. If available, - * the corresponding function in the provided MPI implementation is used. - * Otherwise, the implementation follows the one described in the - * following publication: - * @code{.bib} - * @inproceedings{dinan2011noncollective, - * title = {Noncollective communicator creation in MPI}, - * author = {Dinan, James and Krishnamoorthy, Sriram and Balaji, - * Pavan and Hammond, Jeff R and Krishnan, Manojkumar and - * Tipparaju, Vinod and Vishnu, Abhinav}, - * booktitle = {European MPI Users' Group Meeting}, - * pages = {282--291}, - * year = {2011}, - * organization = {Springer} - * } - * @endcode - * - * @deprecated Use MPI_Comm_create_group directly - */ -#ifdef DEAL_II_WITH_MPI - DEAL_II_DEPRECATED int - create_group(const MPI_Comm comm, - const MPI_Group &group, - const int tag, - MPI_Comm *new_comm); -#endif - /** * Given the number of locally owned elements @p locally_owned_size, * create a 1:1 partitioning of the of elements across the MPI diff --git a/include/deal.II/base/mpi_tags.h b/include/deal.II/base/mpi_tags.h index 69aa044d59..3851239f22 100644 --- a/include/deal.II/base/mpi_tags.h +++ b/include/deal.II/base/mpi_tags.h @@ -40,7 +40,6 @@ namespace Utilities * - MPI_Isend, MPI_Irecv * - MPI_Probe, MPI_Iprobe * - MPI_Comm_create_group, MPI_Intercomm_create, - * Utilities::MPI::create_group */ namespace Tags { diff --git a/include/deal.II/base/symmetric_tensor.h b/include/deal.II/base/symmetric_tensor.h index 3fcccf0132..e73ccbeb07 100644 --- a/include/deal.II/base/symmetric_tensor.h +++ b/include/deal.II/base/symmetric_tensor.h @@ -794,55 +794,6 @@ public: DEAL_II_HOST constexpr explicit SymmetricTensor( const SymmetricTensor &initializer); - /** - * Return a pointer to the first element of the underlying storage. - * - * @deprecated This function suggests that the elements of a SymmetricTensor - * object are stored as a contiguous array, but this is not in fact true - * and one should not pretend that this so. As a consequence, this function - * is deprecated. - */ - DEAL_II_DEPRECATED - Number * - begin_raw(); - - /** - * Return a const pointer to the first element of the underlying storage. - * - * @deprecated This function suggests that the elements of a SymmetricTensor - * object are stored as a contiguous array, but this is not in fact true - * and one should not pretend that this so. As a consequence, this function - * is deprecated. - */ - DEAL_II_DEPRECATED - const Number * - begin_raw() const; - - /** - * Return a pointer to the element past the end of the underlying storage. - * - * @deprecated This function suggests that the elements of a SymmetricTensor - * object are stored as a contiguous array, but this is not in fact true - * and one should not pretend that this so. As a consequence, this function - * is deprecated. - */ - DEAL_II_DEPRECATED - Number * - end_raw(); - - /** - * Return a const pointer to the element past the end of the underlying - * storage. - * - * @deprecated This function suggests that the elements of a SymmetricTensor - * object are stored as a contiguous array, but this is not in fact true - * and one should not pretend that this so. As a consequence, this function - * is deprecated. - */ - DEAL_II_DEPRECATED - const Number * - end_raw() const; - /** * Assignment operator from symmetric tensors with different underlying scalar * type. @@ -2310,42 +2261,6 @@ SymmetricTensor::operator[]( -template -inline Number * -SymmetricTensor::begin_raw() -{ - return std::addressof(this->access_raw_entry(0)); -} - - - -template -inline const Number * -SymmetricTensor::begin_raw() const -{ - return std::addressof(this->access_raw_entry(0)); -} - - - -template -inline Number * -SymmetricTensor::end_raw() -{ - return begin_raw() + n_independent_components; -} - - - -template -inline const Number * -SymmetricTensor::end_raw() const -{ - return begin_raw() + n_independent_components; -} - - - template DEAL_II_HOST constexpr inline const Number & SymmetricTensor::access_raw_entry( diff --git a/include/deal.II/base/tensor.h b/include/deal.II/base/tensor.h index db45ec1225..114c68b964 100644 --- a/include/deal.II/base/tensor.h +++ b/include/deal.II/base/tensor.h @@ -791,20 +791,6 @@ public: typename numbers::NumberTraits::real_type norm_square() const; - /** - * Fill a vector with all tensor elements. - * - * This function unrolls all tensor entries into a single, linearly numbered - * vector. As usual in C++, the rightmost index of the tensor marches - * fastest. - * - * @deprecated Use the more general function that takes a pair of iterators - * instead. - */ - template - DEAL_II_DEPRECATED void - unroll(Vector &result) const; - /** * Fill a range with all tensor elements. * @@ -1807,16 +1793,6 @@ constexpr DEAL_II_HOST_DEVICE_ALWAYS_INLINE -template -template -inline void -Tensor::unroll(Vector &result) const -{ - unroll(result.begin(), result.end()); -} - - - template template inline void diff --git a/include/deal.II/distributed/fully_distributed_tria.h b/include/deal.II/distributed/fully_distributed_tria.h index 5480ee3b2b..a5355d5a25 100644 --- a/include/deal.II/distributed/fully_distributed_tria.h +++ b/include/deal.II/distributed/fully_distributed_tria.h @@ -257,7 +257,7 @@ namespace parallel * must be empty before calling this function. * * You need to load with the same number of MPI processes that - * you saved with, hence autopartition is disabled. + * you saved with. * * Cell-based data that was saved with register_data_attach() can be read * in with notify_ready_to_unpack() after calling load(). @@ -265,15 +265,6 @@ namespace parallel virtual void load(const std::string &filename) override; - /** - * @copydoc load() - * - * @deprecated The autopartition parameter has been removed. - */ - DEAL_II_DEPRECATED - virtual void - load(const std::string &filename, const bool autopartition) override; - private: virtual unsigned int coarse_cell_id_to_coarse_cell_index( diff --git a/include/deal.II/distributed/tria.h b/include/deal.II/distributed/tria.h index 05a2aaf4ca..4992c0639d 100644 --- a/include/deal.II/distributed/tria.h +++ b/include/deal.II/distributed/tria.h @@ -662,15 +662,6 @@ namespace parallel virtual void load(const std::string &file_basename) override; - /** - * @copydoc load() - * - * @deprecated The autopartition parameter has been removed. - */ - DEAL_II_DEPRECATED - virtual void - load(const std::string &filename, const bool autopartition) override; - /** * Load the refinement information from a given parallel forest. This * forest might be obtained from the function call to @@ -933,14 +924,6 @@ namespace parallel virtual void load(const std::string &filename) override; - /** - * This function is not implemented, but needs to be present for the - * compiler. - */ - DEAL_II_DEPRECATED - virtual void - load(const std::string &filename, const bool autopartition) override; - /** * This function is not implemented, but needs to be present for the * compiler. @@ -1092,16 +1075,6 @@ namespace parallel load(const std::string & /*filename*/) override {} - /** - * Dummy replacement to allow for better error messages when compiling - * this class. - */ - DEAL_II_DEPRECATED - virtual void - load(const std::string & /*filename*/, - const bool /*autopartition*/) override - {} - /** * Dummy replacement to allow for better error messages when compiling * this class. diff --git a/include/deal.II/distributed/tria_base.h b/include/deal.II/distributed/tria_base.h index dc91bb8470..c9f8fc6cba 100644 --- a/include/deal.II/distributed/tria_base.h +++ b/include/deal.II/distributed/tria_base.h @@ -505,16 +505,6 @@ namespace parallel * spacedim>::load. */ using Triangulation::load; - - - /** - * Same as the function above. - * - * @deprecated The autopartition parameter has been removed. - */ - DEAL_II_DEPRECATED - virtual void - load(const std::string &filename, const bool autopartition) = 0; }; } // namespace parallel diff --git a/include/deal.II/dofs/dof_handler.h b/include/deal.II/dofs/dof_handler.h index d2f17c369e..5dabc8ae05 100644 --- a/include/deal.II/dofs/dof_handler.h +++ b/include/deal.II/dofs/dof_handler.h @@ -520,35 +520,11 @@ public: */ static const types::fe_index default_fe_index = 0; - /** - * Invalid index of the finite element to be used on a given cell. - * - * @deprecated Use numbers::invalid_fe_index instead. - */ - static const unsigned int invalid_fe_index DEAL_II_DEPRECATED = - numbers::invalid_fe_index; - - /** - * The type in which we store the active FE index. - * - * @deprecated Use types::fe_index instead. - */ - using active_fe_index_type DEAL_II_DEPRECATED = types::fe_index; - /** * The type in which we store the offsets in the CRS data structures. */ using offset_type = unsigned int; - /** - * Invalid active FE index which will be used as a default value to determine - * whether a future FE index has been set or not. - * - * @deprecated Use numbers::invalid_fe_index instead. - */ - static const types::fe_index invalid_active_fe_index DEAL_II_DEPRECATED = - numbers::invalid_fe_index; - /** * Standard constructor, not initializing any data. After constructing an * object with this constructor, use reinit() to get a valid DoFHandler. diff --git a/include/deal.II/fe/mapping_q.h b/include/deal.II/fe/mapping_q.h index cc0374af62..fe20dd2a1e 100644 --- a/include/deal.II/fe/mapping_q.h +++ b/include/deal.II/fe/mapping_q.h @@ -116,15 +116,6 @@ public: */ MappingQ(const unsigned int polynomial_degree); - /** - * The second argument is here for backward compatibility with previous - * versions of deal.II, but it does not have any effect on the workings of - * this class. - */ - DEAL_II_DEPRECATED - MappingQ(const unsigned int polynomial_degree, - const bool use_mapping_q_on_all_cells); - /** * Copy constructor. */ diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index 516d054a27..61b22d0b1e 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -269,27 +269,6 @@ namespace GridTools const double angle, Triangulation &triangulation); - /** - * Rotate all vertices of the given @p triangulation in counter-clockwise - * direction around the axis with the given index. Otherwise like the - * function above; in particular, this function calls the transform() function - * and so the discussion about manifolds there also applies here. - * - * @param[in] angle Angle in radians to rotate the Triangulation by. - * @param[in] axis Index of the coordinate axis to rotate around, keeping - * that coordinate fixed (0=x axis, 1=y axis, 2=z axis). - * @param[in,out] triangulation The Triangulation object to rotate. - * - * @note Implemented for dim=1, 2, and 3. - * - * @deprecated Use the alternative with the unit vector instead. - */ - template - DEAL_II_DEPRECATED void - rotate(const double angle, - const unsigned int axis, - Triangulation &triangulation); - /** * Transform the given triangulation smoothly to a different domain where, * typically, each of the vertices at the boundary of the triangulation is diff --git a/include/deal.II/lac/slepc_spectral_transformation.h b/include/deal.II/lac/slepc_spectral_transformation.h index 7a05e8ca7d..d1ed243b8a 100644 --- a/include/deal.II/lac/slepc_spectral_transformation.h +++ b/include/deal.II/lac/slepc_spectral_transformation.h @@ -198,51 +198,6 @@ namespace SLEPcWrappers friend class SolverBase; }; - /** - * An implementation of the transformation interface using the SLEPc - * Spectrum Folding. This transformation type has been removed in SLEPc - * 3.5.0 and thus cannot be used in the newer versions. - * - * @deprecated Since deal.II requires PETSc 3.7 or newer this class no longer - * does anything. - * - * @ingroup SLEPcWrappers - */ - class DEAL_II_DEPRECATED TransformationSpectrumFolding - : public TransformationBase - { - public: - /** - * Standardized data struct to pipe additional data to the solver. - */ - struct AdditionalData - { - /** - * Constructor. By default, set the shift parameter to zero. - */ - explicit AdditionalData(const double shift_parameter = 0); - - /** - * Shift parameter. - */ - const double shift_parameter; - }; - - - /** - * Constructor. - */ - explicit TransformationSpectrumFolding( - const MPI_Comm mpi_communicator, - const AdditionalData &data = AdditionalData()); - - protected: - /** - * Store a copy of the flags for this particular solver. - */ - const AdditionalData additional_data; - }; - /** * An implementation of the transformation interface using the SLEPc Cayley. * diff --git a/include/deal.II/particles/particle_accessor.h b/include/deal.II/particles/particle_accessor.h index a4ff6dba1a..58a1b4224f 100644 --- a/include/deal.II/particles/particle_accessor.h +++ b/include/deal.II/particles/particle_accessor.h @@ -350,21 +350,6 @@ namespace Particles ArrayView get_properties() const; - /** - * Tell the particle where to store its properties (even if it does not - * own properties). Usually this is only done once per particle, but - * since the particle generator does not know about the properties - * we want to do it not at construction time. Another use for this - * function is after particle transfer to a new process. - * - * @deprecated This function is only kept for backward compatibility - * and has no meaning any more. ParticleAccessors always use the - * property pool of the owning particle handler. - */ - DEAL_II_DEPRECATED - void - set_property_pool(PropertyPool &property_pool); - /** * Return the size in bytes this particle occupies if all of its data is * serialized (i.e. the number of bytes that is written by the write_data @@ -392,10 +377,6 @@ namespace Particles * Read the data of this object from a stream for the purpose of * serialization using the [BOOST serialization * library](https://www.boost.org/doc/libs/1_74_0/libs/serialization/doc/index.html). - * Note that in order to store the properties correctly, the property pool - * of this particle has to be known at the time of reading, i.e. - * set_property_pool() has to have been called, before this function is - * called. */ template void @@ -830,17 +811,6 @@ namespace Particles - template - inline void - ParticleAccessor::set_property_pool( - PropertyPool &new_property_pool) - { - Assert(&new_property_pool == property_pool, ExcInternalError()); - (void)new_property_pool; - } - - - template inline const typename Triangulation::cell_iterator & ParticleAccessor::get_surrounding_cell() const diff --git a/include/deal.II/particles/particle_handler.h b/include/deal.II/particles/particle_handler.h index 4d9eada9bc..482bbd4929 100644 --- a/include/deal.II/particles/particle_handler.h +++ b/include/deal.II/particles/particle_handler.h @@ -790,34 +790,6 @@ namespace Particles void deserialize(); - /** - * Callback function that should be called before every refinement - * and when writing checkpoints. This function is used to - * register pack_callback() with the triangulation. This function - * is used in step-70. - * - * @deprecated Please use prepare_for_coarsening_and_refinement() or - * prepare_for_serialization() instead. See there for further information - * about the purpose of this function. - */ - DEAL_II_DEPRECATED - void - register_store_callback_function(); - - /** - * Callback function that should be called after every refinement - * and after resuming from a checkpoint. This function is used to - * register unpack_callback() with the triangulation. This function - * is used in step-70. - * - * @deprecated Please use unpack_after_coarsening_and_refinement() or - * deserialize() instead. See there for further information about the - * purpose of this function. - */ - DEAL_II_DEPRECATED - void - register_load_callback_function(const bool serialization); - /** * Serialize the contents of this class using the [BOOST serialization * library](https://www.boost.org/doc/libs/1_74_0/libs/serialization/doc/index.html). diff --git a/include/deal.II/physics/transformations.h b/include/deal.II/physics/transformations.h index 4043073683..b1af26b135 100644 --- a/include/deal.II/physics/transformations.h +++ b/include/deal.II/physics/transformations.h @@ -90,15 +90,6 @@ namespace Physics Tensor<2, 3, Number> rotation_matrix_3d(const Tensor<1, 3, Number> &axis, const Number &angle); - /** - * @copydoc Physics::Transformations::Rotations::rotation_matrix_3d() - * - * @deprecated Use the variant with a Tensor as an axis. - */ - template - DEAL_II_DEPRECATED Tensor<2, 3, Number> - rotation_matrix_3d(const Point<3, Number> &axis, const Number &angle); - /** @} */ } // namespace Rotations @@ -952,17 +943,6 @@ Physics::Transformations::Rotations::rotation_matrix_3d( -template -Tensor<2, 3, Number> -Physics::Transformations::Rotations::rotation_matrix_3d( - const Point<3, Number> &axis, - const Number &angle) -{ - return rotation_matrix_3d(static_cast>(axis), angle); -} - - - template inline Tensor<1, dim, Number> Physics::Transformations::Contravariant::push_forward( diff --git a/source/base/data_out_base.cc b/source/base/data_out_base.cc index 97d782a0ad..a3449bd4b8 100644 --- a/source/base/data_out_base.cc +++ b/source/base/data_out_base.cc @@ -9396,14 +9396,6 @@ XDMFEntry::XDMFEntry() -XDMFEntry::XDMFEntry(const std::string &filename, - const double time, - const std::uint64_t nodes, - const std::uint64_t cells, - const unsigned int dim) - : XDMFEntry(filename, filename, time, nodes, cells, dim, dim, ReferenceCell()) -{} - XDMFEntry::XDMFEntry(const std::string &filename, const double time, const std::uint64_t nodes, @@ -9415,24 +9407,6 @@ XDMFEntry::XDMFEntry(const std::string &filename, -XDMFEntry::XDMFEntry(const std::string &mesh_filename, - const std::string &solution_filename, - const double time, - const std::uint64_t nodes, - const std::uint64_t cells, - const unsigned int dim) - : XDMFEntry(mesh_filename, - solution_filename, - time, - nodes, - cells, - dim, - dim, - ReferenceCell()) -{} - - - XDMFEntry::XDMFEntry(const std::string &mesh_filename, const std::string &solution_filename, const double time, @@ -9452,25 +9426,6 @@ XDMFEntry::XDMFEntry(const std::string &mesh_filename, -XDMFEntry::XDMFEntry(const std::string &mesh_filename, - const std::string &solution_filename, - const double time, - const std::uint64_t nodes, - const std::uint64_t cells, - const unsigned int dim, - const unsigned int spacedim) - : XDMFEntry(mesh_filename, - solution_filename, - time, - nodes, - cells, - dim, - spacedim, - ReferenceCell()) -{} - - - namespace { /** @@ -9551,19 +9506,6 @@ namespace -std::string -XDMFEntry::get_xdmf_content(const unsigned int indent_level, - const ReferenceCell &reference_cell) const -{ - // We now store the type of cell in the XDMFEntry: - (void)reference_cell; - Assert(cell_type == reference_cell, - internal::ExcNonMatchingReferenceCellTypes(cell_type, reference_cell)); - return get_xdmf_content(indent_level); -} - - - std::string XDMFEntry::get_xdmf_content(const unsigned int indent_level) const { diff --git a/source/base/mpi.cc b/source/base/mpi.cc index 12b8fa91f5..b68f6c8a0a 100644 --- a/source/base/mpi.cc +++ b/source/base/mpi.cc @@ -160,19 +160,6 @@ namespace Utilities - int - create_group(const MPI_Comm comm, - const MPI_Group &group, - const int tag, - MPI_Comm *new_comm) - { - const int ierr = MPI_Comm_create_group(comm, group, tag, new_comm); - AssertThrowMPI(ierr); - return ierr; - } - - - std::vector create_ascending_partitioning( const MPI_Comm comm, diff --git a/source/distributed/fully_distributed_tria.cc b/source/distributed/fully_distributed_tria.cc index 33b78780a6..a7f3fae58f 100644 --- a/source/distributed/fully_distributed_tria.cc +++ b/source/distributed/fully_distributed_tria.cc @@ -736,17 +736,6 @@ namespace parallel - template - DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim)) - void Triangulation::load(const std::string &filename, - const bool autopartition) - { - (void)autopartition; - load(filename); - } - - - template DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim)) void Triangulation::update_number_cache() diff --git a/source/distributed/tria.cc b/source/distributed/tria.cc index ac416c3f32..c01fb051a9 100644 --- a/source/distributed/tria.cc +++ b/source/distributed/tria.cc @@ -2204,17 +2204,6 @@ namespace parallel - template - DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim)) - void Triangulation::load(const std::string &filename, - const bool autopartition) - { - (void)autopartition; - load(filename); - } - - - template DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim)) void Triangulation::load( @@ -4245,15 +4234,6 @@ namespace parallel - template - DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<1, spacedim>)) - void Triangulation<1, spacedim>::load(const std::string &, const bool) - { - DEAL_II_NOT_IMPLEMENTED(); - } - - - template DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<1, spacedim>)) void Triangulation<1, spacedim>::save(const std::string &) const diff --git a/source/fe/mapping_q.cc b/source/fe/mapping_q.cc index c51f40bf7e..d6e3141f6f 100644 --- a/source/fe/mapping_q.cc +++ b/source/fe/mapping_q.cc @@ -242,13 +242,6 @@ MappingQ::MappingQ(const unsigned int p) -template -MappingQ::MappingQ(const unsigned int p, const bool) - : MappingQ(p) -{} - - - template MappingQ::MappingQ(const MappingQ &mapping) : polynomial_degree(mapping.polynomial_degree) diff --git a/source/grid/grid_tools.cc b/source/grid/grid_tools.cc index 327ac1b888..0afe7ca0f8 100644 --- a/source/grid/grid_tools.cc +++ b/source/grid/grid_tools.cc @@ -236,21 +236,6 @@ namespace GridTools } - template - void - rotate(const double angle, - const unsigned int axis, - Triangulation &triangulation) - { - Assert(axis < 3, ExcMessage("Invalid axis given!")); - - Tensor<1, 3, double> vector; - vector[axis] = 1.; - - transform(internal::Rotate3d(vector, angle), triangulation); - } - - template void scale(const double scaling_factor, diff --git a/source/grid/grid_tools.inst.in b/source/grid/grid_tools.inst.in index d64f20eb15..167c272d85 100644 --- a/source/grid/grid_tools.inst.in +++ b/source/grid/grid_tools.inst.in @@ -280,12 +280,6 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) const Tensor<1, deal_II_space_dimension, double> &, const double, Triangulation &); - - template void - rotate( - const double, - const unsigned int, - Triangulation &); # endif template void diff --git a/source/lac/slepc_spectral_transformation.cc b/source/lac/slepc_spectral_transformation.cc index 64bc907348..a6f1045e60 100644 --- a/source/lac/slepc_spectral_transformation.cc +++ b/source/lac/slepc_spectral_transformation.cc @@ -97,27 +97,6 @@ namespace SLEPcWrappers AssertThrow(ierr == 0, SolverBase::ExcSLEPcError(ierr)); } - /* --------------- TransformationSpectrumFolding ----------------- */ - - TransformationSpectrumFolding::AdditionalData::AdditionalData( - const double shift_parameter) - : shift_parameter(shift_parameter) - {} - - TransformationSpectrumFolding::TransformationSpectrumFolding( - const MPI_Comm mpi_communicator, - const AdditionalData &data) - : TransformationBase(mpi_communicator) - , additional_data(data) - { - // This feature is only in PETSc/SLEPc versions 3.4 or older, which we no - // longer support. - Assert(false, - ExcMessage( - "Folding transformation has been removed in SLEPc 3.5.0 and newer." - " You cannot use this transformation anymore.")); - } - /* ------------------- TransformationCayley --------------------- */ TransformationCayley::AdditionalData::AdditionalData( diff --git a/source/particles/particle_handler.cc b/source/particles/particle_handler.cc index 1ae650e2e1..d250df29f6 100644 --- a/source/particles/particle_handler.cc +++ b/source/particles/particle_handler.cc @@ -2181,15 +2181,6 @@ namespace Particles - template - void - ParticleHandler::register_store_callback_function() - { - register_data_attach(); - } - - - template void ParticleHandler::register_data_attach() @@ -2228,16 +2219,6 @@ namespace Particles } - template - void - ParticleHandler::register_load_callback_function( - const bool serialization) - { - notify_ready_to_unpack(serialization); - } - - - template void ParticleHandler::notify_ready_to_unpack( diff --git a/tests/mpi/create_group_01.cc b/tests/mpi/create_group_01.cc deleted file mode 100644 index 9387022bad..0000000000 --- a/tests/mpi/create_group_01.cc +++ /dev/null @@ -1,59 +0,0 @@ -// ------------------------------------------------------------------------ -// -// SPDX-License-Identifier: LGPL-2.1-or-later -// Copyright (C) 2018 by the deal.II authors -// -// This file is part of the deal.II library. -// -// Part of the source code is dual licensed under Apache-2.0 WITH -// LLVM-exception OR LGPL-2.1-or-later. Detailed license information -// governing the source code and code contributions can be found in -// LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II. -// -// ------------------------------------------------------------------------ - - - -// check that Utilities::MPI::create_group is only collective over the group of -// processes that actually want to create the communicator. -// In p4est-2.0, sc_init() leads to a deadlock when MPI_Comm_create_group is -// called (see https://github.com/cburstedde/p4est/issues/30). Hence, this test -// also ensures that the treatment of sc_init() is appropriate. - -#include "../tests.h" - -int -main(int argc, char *argv[]) -{ - Utilities::MPI::MPI_InitFinalize mpi_init(argc, argv, 1); - MPILogInitAll log_all; - - const MPI_Comm global_comm = MPI_COMM_WORLD; - - const unsigned int my_id = Utilities::MPI::this_mpi_process(global_comm); - const unsigned int n_ranks = Utilities::MPI::n_mpi_processes(global_comm); - - // Get the group of processes in MPI_COMM_WORLD - MPI_Group world_group; - int ierr = MPI_Comm_group(MPI_COMM_WORLD, &world_group); - AssertThrowMPI(ierr); - - const int n = n_ranks / 2; - std::vector ranks; - for (unsigned int i = 0; i < n_ranks; i += 2) - ranks.push_back(i); - - // Construct a group containing all of the even ranks in world_group - MPI_Group even_group; - ierr = MPI_Group_incl(world_group, n, ranks.data(), &even_group); - AssertThrowMPI(ierr); - - if (my_id % 2 == 0) - { - MPI_Comm group_comm; - ierr = - Utilities::MPI::create_group(global_comm, even_group, 0, &group_comm); - AssertThrowMPI(ierr); - } - deallog << "OK" << std::endl; -} diff --git a/tests/mpi/create_group_01.mpirun=3.output b/tests/mpi/create_group_01.mpirun=3.output deleted file mode 100644 index 3342d14fa8..0000000000 --- a/tests/mpi/create_group_01.mpirun=3.output +++ /dev/null @@ -1,8 +0,0 @@ - -DEAL:0::OK - -DEAL:1::OK - - -DEAL:2::OK - diff --git a/tests/mpi/data_out_hdf5_02.cc b/tests/mpi/data_out_hdf5_02.cc index 7f77902816..13369822ed 100644 --- a/tests/mpi/data_out_hdf5_02.cc +++ b/tests/mpi/data_out_hdf5_02.cc @@ -66,7 +66,8 @@ check() data_filter.n_nodes(), data_filter.n_cells(), dim, - spacedim); + spacedim, + ReferenceCell()); unsigned int n_data_sets = data_filter.n_data_sets(); // The vector names generated here must match those generated in the HDF5 file diff --git a/tests/mpi/p4est_save_01.cc b/tests/mpi/p4est_save_01.cc index 728ee9cb30..7e56ec94a0 100644 --- a/tests/mpi/p4est_save_01.cc +++ b/tests/mpi/p4est_save_01.cc @@ -82,7 +82,7 @@ test() parallel::distributed::Triangulation tr(MPI_COMM_WORLD); GridGenerator::hyper_cube(tr); - tr.load(filename.c_str(), false); + tr.load(filename.c_str()); if (myid == 0) { diff --git a/tests/mpi/p4est_save_02.cc b/tests/mpi/p4est_save_02.cc index a7c20387e0..cb273e2e82 100644 --- a/tests/mpi/p4est_save_02.cc +++ b/tests/mpi/p4est_save_02.cc @@ -112,7 +112,7 @@ test() parallel::distributed::Triangulation tr(MPI_COMM_WORLD); GridGenerator::hyper_cube(tr); - tr.load(filename.c_str(), false); + tr.load(filename.c_str()); FE_Q fe(1); DoFHandler dh(tr); diff --git a/tests/mpi/p4est_save_03.cc b/tests/mpi/p4est_save_03.cc index 0ed17a462b..0bea74f3ce 100644 --- a/tests/mpi/p4est_save_03.cc +++ b/tests/mpi/p4est_save_03.cc @@ -124,7 +124,7 @@ test() parallel::distributed::Triangulation tr(MPI_COMM_WORLD); GridGenerator::hyper_cube(tr); - tr.load(filename.c_str(), false); + tr.load(filename.c_str()); FE_Q fe(1); DoFHandler dh(tr); diff --git a/tests/particles/step-19.cc b/tests/particles/step-19.cc index 6052713310..810c6d4dc8 100644 --- a/tests/particles/step-19.cc +++ b/tests/particles/step-19.cc @@ -754,7 +754,9 @@ namespace Step19 deallog << "Setting new velocity of particle " << particle->get_id() << ": " << new_velocity << std::endl; - particle->set_properties(make_array_view(new_velocity)); + particle->set_properties( + make_array_view(new_velocity.begin_raw(), + new_velocity.end_raw())); // With the new velocity, we can then also update the location // of the particle and tell the particle about it. diff --git a/tests/tensors/tensor.cc b/tests/tensors/tensor.cc index a35fc8119e..6b3135913a 100644 --- a/tests/tensors/tensor.cc +++ b/tests/tensors/tensor.cc @@ -38,7 +38,7 @@ main() Vector unrolled(9); - t.unroll(unrolled); + t.unroll(unrolled.data(), unrolled.data() + 9); deallog << "unrolled:"; for (unsigned i = 0; i < 9; ++i) deallog << ' ' << unrolled(i); diff --git a/tests/tensors/tensor_complex.cc b/tests/tensors/tensor_complex.cc index 6f0f1a9c7b..f2f6e2e791 100644 --- a/tests/tensors/tensor_complex.cc +++ b/tests/tensors/tensor_complex.cc @@ -56,7 +56,7 @@ main() // cast result to double to profit from zero // threshold and so on - t.unroll(unrolled); + t.unroll(unrolled.data(), unrolled.data() + 9); deallog << "unrolled:"; for (unsigned i = 0; i < 9; ++i) deallog << ' ' << unrolled(i); diff --git a/tests/tensors/tensor_float.cc b/tests/tensors/tensor_float.cc index ade4f2efb1..116a128680 100644 --- a/tests/tensors/tensor_float.cc +++ b/tests/tensors/tensor_float.cc @@ -41,7 +41,7 @@ main() // cast result to double to profit from zero // threshold and so on - t.unroll(unrolled); + t.unroll(unrolled.data(), unrolled.data() + 9); deallog << "unrolled:"; for (unsigned i = 0; i < 9; ++i) deallog << ' ' << static_cast(unrolled(i)); -- 2.39.5