]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove 9.5 release deprecations 17444/head
authorDaniel Arndt <arndtd@ornl.gov>
Tue, 6 Aug 2024 21:03:09 +0000 (17:03 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Wed, 7 Aug 2024 15:35:30 +0000 (11:35 -0400)
36 files changed:
doc/news/changes/20240807DanielArndt [new file with mode: 0644]
include/deal.II/base/array_view.h
include/deal.II/base/data_out_base.h
include/deal.II/base/mpi.h
include/deal.II/base/mpi_tags.h
include/deal.II/base/symmetric_tensor.h
include/deal.II/base/tensor.h
include/deal.II/distributed/fully_distributed_tria.h
include/deal.II/distributed/tria.h
include/deal.II/distributed/tria_base.h
include/deal.II/dofs/dof_handler.h
include/deal.II/fe/mapping_q.h
include/deal.II/grid/grid_tools.h
include/deal.II/lac/slepc_spectral_transformation.h
include/deal.II/particles/particle_accessor.h
include/deal.II/particles/particle_handler.h
include/deal.II/physics/transformations.h
source/base/data_out_base.cc
source/base/mpi.cc
source/distributed/fully_distributed_tria.cc
source/distributed/tria.cc
source/fe/mapping_q.cc
source/grid/grid_tools.cc
source/grid/grid_tools.inst.in
source/lac/slepc_spectral_transformation.cc
source/particles/particle_handler.cc
tests/mpi/create_group_01.cc [deleted file]
tests/mpi/create_group_01.mpirun=3.output [deleted file]
tests/mpi/data_out_hdf5_02.cc
tests/mpi/p4est_save_01.cc
tests/mpi/p4est_save_02.cc
tests/mpi/p4est_save_03.cc
tests/particles/step-19.cc
tests/tensors/tensor.cc
tests/tensors/tensor_complex.cc
tests/tensors/tensor_float.cc

diff --git a/doc/news/changes/20240807DanielArndt b/doc/news/changes/20240807DanielArndt
new file mode 100644 (file)
index 0000000..467bc35
--- /dev/null
@@ -0,0 +1,4 @@
+Removed: Deprecations from the 9.5 release have been removed.
+See https://github.com/dealii/dealii/pull/17444 for details.
+<br>
+(Daniel Arndt, 2024/08/07)
index dcfcd17e5700a9ea13437ab3853dbf108dd66fb8..213382e17fec272a0e42c1277808e2e84bc790bd 100644 (file)
@@ -1030,137 +1030,6 @@ make_array_view(ArrayView<Number, MemorySpaceType> &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 <em>entire</em> 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 <int rank, int dim, typename Number>
-DEAL_II_DEPRECATED inline ArrayView<const Number>
-make_array_view(const Tensor<rank, dim, Number> &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 <em>entire</em> 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 <int rank, int dim, typename Number>
-DEAL_II_DEPRECATED inline ArrayView<Number>
-make_array_view(Tensor<rank, dim, Number> &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 <em>entire</em> 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 <int rank, int dim, typename Number>
-DEAL_II_DEPRECATED inline ArrayView<const Number>
-make_array_view(const SymmetricTensor<rank, dim, Number> &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 <em>entire</em> 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 <int rank, int dim, typename Number>
-DEAL_II_DEPRECATED inline ArrayView<Number>
-make_array_view(SymmetricTensor<rank, dim, Number> &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
index daaa77d13c561ea853769fd4b7fc77a2e7ed2fb4..a9c8c0cb3bdc7510ec7dcba2226c431c0ea92f42 100644 (file)
@@ -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 <tt>best_speed</tt>.
@@ -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 <code>dim==spacedim</code>.
@@ -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.
index 69fc7be7d2b18bd8d05e831cfdcb72fd5066137c..54869d3bd8b241c977777b990e1913cb1ba214b0 100644 (file)
@@ -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
index 69aa044d5927373196673378fc52445771f3265a..3851239f22cd4111a09f986a6abccd0ed7fd34ae 100644 (file)
@@ -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
       {
index 3fcccf0132c61c051487a425ddb3b8fa805e6a63..e73ccbeb07a7d105682b64f859ae80551f898755 100644 (file)
@@ -794,55 +794,6 @@ public:
   DEAL_II_HOST constexpr explicit SymmetricTensor(
     const SymmetricTensor<rank_, dim, OtherNumber> &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<rank_, dim, Number>::operator[](
 
 
 
-template <int rank_, int dim, typename Number>
-inline Number *
-SymmetricTensor<rank_, dim, Number>::begin_raw()
-{
-  return std::addressof(this->access_raw_entry(0));
-}
-
-
-
-template <int rank_, int dim, typename Number>
-inline const Number *
-SymmetricTensor<rank_, dim, Number>::begin_raw() const
-{
-  return std::addressof(this->access_raw_entry(0));
-}
-
-
-
-template <int rank_, int dim, typename Number>
-inline Number *
-SymmetricTensor<rank_, dim, Number>::end_raw()
-{
-  return begin_raw() + n_independent_components;
-}
-
-
-
-template <int rank_, int dim, typename Number>
-inline const Number *
-SymmetricTensor<rank_, dim, Number>::end_raw() const
-{
-  return begin_raw() + n_independent_components;
-}
-
-
-
 template <int rank_, int dim, typename Number>
 DEAL_II_HOST constexpr inline const Number &
 SymmetricTensor<rank_, dim, Number>::access_raw_entry(
index db45ec1225674b8d896cff4a6e21903f10ec972a..114c68b9644be3b4a093679376154f0f61521a4e 100644 (file)
@@ -791,20 +791,6 @@ public:
     typename numbers::NumberTraits<Number>::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 <typename OtherNumber>
-  DEAL_II_DEPRECATED void
-  unroll(Vector<OtherNumber> &result) const;
-
   /**
    * Fill a range with all tensor elements.
    *
@@ -1807,16 +1793,6 @@ constexpr DEAL_II_HOST_DEVICE_ALWAYS_INLINE
 
 
 
-template <int rank_, int dim, typename Number>
-template <typename OtherNumber>
-inline void
-Tensor<rank_, dim, Number>::unroll(Vector<OtherNumber> &result) const
-{
-  unroll(result.begin(), result.end());
-}
-
-
-
 template <int rank_, int dim, typename Number>
 template <class Iterator>
 inline void
index 5480ee3b2b9d2262615a49aaaa929d50910f7be9..a5355d5a25884a3f929920383eef4c34b6ae7bd9 100644 (file)
@@ -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(
index 05a2aaf4ca61535c5e7620d6211ef6310f67d903..4992c0639d2e442c52a17efc7c2576e6103d452d 100644 (file)
@@ -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.
index dc91bb84709ea58681b7212f8b3904a178a0246f..c9f8fc6cba9eb401943238a9e6be3c580c4c7560 100644 (file)
@@ -505,16 +505,6 @@ namespace parallel
      * spacedim>::load.
      */
     using Triangulation<dim, spacedim>::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
index d2f17c369ebe13fa96d4dd622fe80aa174d8e81a..5dabc8ae05feb61f86813307ecf006a2616b6489 100644 (file)
@@ -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.
index cc0374af62a91d8a84c9c4a5a612e4a5f499af99..fe20dd2a1eeb4d3677b1162ea68a413b705eeeb9 100644 (file)
@@ -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.
    */
index 516d054a2746f9953b4708e1f4e56f69d2645924..61b22d0b1ea641bb7633da165a4f81069fd76492 100644 (file)
@@ -269,27 +269,6 @@ namespace GridTools
          const double                angle,
          Triangulation<dim, 3>      &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 <int dim>
-  DEAL_II_DEPRECATED void
-  rotate(const double           angle,
-         const unsigned int     axis,
-         Triangulation<dim, 3> &triangulation);
-
   /**
    * Transform the given triangulation smoothly to a different domain where,
    * typically, each of the vertices at the boundary of the triangulation is
index 7a05e8ca7d0c4e291de13d9adce8af7a5f389ad3..d1ed243b8a51ea763a7fca43bb7a6b9ec59b6090 100644 (file)
@@ -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.
    *
index a4ff6dba1a408189ec1408e21c56aded78c8dc3d..58a1b4224f28c63c168fe5762edd766df0653129 100644 (file)
@@ -350,21 +350,6 @@ namespace Particles
     ArrayView<const double>
     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<dim, spacedim> &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 <class Archive>
     void
@@ -830,17 +811,6 @@ namespace Particles
 
 
 
-  template <int dim, int spacedim>
-  inline void
-  ParticleAccessor<dim, spacedim>::set_property_pool(
-    PropertyPool<dim, spacedim> &new_property_pool)
-  {
-    Assert(&new_property_pool == property_pool, ExcInternalError());
-    (void)new_property_pool;
-  }
-
-
-
   template <int dim, int spacedim>
   inline const typename Triangulation<dim, spacedim>::cell_iterator &
   ParticleAccessor<dim, spacedim>::get_surrounding_cell() const
index 4d9eada9bce29e1112b7ed0640cd7284b2c92a4f..482bbd49298502b67ae42ec025b13bec30cf8c9b 100644 (file)
@@ -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).
index 40430736834535b5c9cbc728d953a4d3aa0df0a1..b1af26b13592920aca048b8816e34b6796ba1db7 100644 (file)
@@ -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 <typename Number>
-      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 <typename Number>
-Tensor<2, 3, Number>
-Physics::Transformations::Rotations::rotation_matrix_3d(
-  const Point<3, Number> &axis,
-  const Number           &angle)
-{
-  return rotation_matrix_3d(static_cast<Tensor<1, 3, Number>>(axis), angle);
-}
-
-
-
 template <int dim, typename Number>
 inline Tensor<1, dim, Number>
 Physics::Transformations::Contravariant::push_forward(
index 97d782a0adf4c815e5c4c1089c450a8120682dbb..a3449bd4b8f1c7c911e3523a2930770ebeb6bdec 100644 (file)
@@ -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
 {
index 12b8fa91f548338d0c181d70fe23592b05633caf..b68f6c8a0aa6eebb15f1fbc789b72b292fc8914b 100644 (file)
@@ -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<IndexSet>
     create_ascending_partitioning(
       const MPI_Comm                comm,
index 33b78780a616cfa06108075a63d7518b843f4cbc..a7f3fae58ff3fbed6a34a5f2285ec43c3a204269 100644 (file)
@@ -736,17 +736,6 @@ namespace parallel
 
 
 
-    template <int dim, int spacedim>
-    DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
-    void Triangulation<dim, spacedim>::load(const std::string &filename,
-                                            const bool         autopartition)
-    {
-      (void)autopartition;
-      load(filename);
-    }
-
-
-
     template <int dim, int spacedim>
     DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
     void Triangulation<dim, spacedim>::update_number_cache()
index ac416c3f327cb82e697627775f51c209a0faa86e..c01fb051a998a543bb53e4e1cdd33aca6e1c7d45 100644 (file)
@@ -2204,17 +2204,6 @@ namespace parallel
 
 
 
-    template <int dim, int spacedim>
-    DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
-    void Triangulation<dim, spacedim>::load(const std::string &filename,
-                                            const bool         autopartition)
-    {
-      (void)autopartition;
-      load(filename);
-    }
-
-
-
     template <int dim, int spacedim>
     DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
     void Triangulation<dim, spacedim>::load(
@@ -4245,15 +4234,6 @@ namespace parallel
 
 
 
-    template <int spacedim>
-    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 <int spacedim>
     DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<1, spacedim>))
     void Triangulation<1, spacedim>::save(const std::string &) const
index c51f40bf7e7b1830ddb08e06cd72408b48239430..d6e3141f6f361c0cfbb7c960a472396cfd5808c3 100644 (file)
@@ -242,13 +242,6 @@ MappingQ<dim, spacedim>::MappingQ(const unsigned int p)
 
 
 
-template <int dim, int spacedim>
-MappingQ<dim, spacedim>::MappingQ(const unsigned int p, const bool)
-  : MappingQ<dim, spacedim>(p)
-{}
-
-
-
 template <int dim, int spacedim>
 MappingQ<dim, spacedim>::MappingQ(const MappingQ<dim, spacedim> &mapping)
   : polynomial_degree(mapping.polynomial_degree)
index 327ac1b888fa8745be10d7f8de37a9831ba9ec10..0afe7ca0f85fa4e2bf62b30229ed239885ead977 100644 (file)
@@ -236,21 +236,6 @@ namespace GridTools
   }
 
 
-  template <int dim>
-  void
-  rotate(const double           angle,
-         const unsigned int     axis,
-         Triangulation<dim, 3> &triangulation)
-  {
-    Assert(axis < 3, ExcMessage("Invalid axis given!"));
-
-    Tensor<1, 3, double> vector;
-    vector[axis] = 1.;
-
-    transform(internal::Rotate3d(vector, angle), triangulation);
-  }
-
-
   template <int dim, int spacedim>
   void
   scale(const double                  scaling_factor,
index d64f20eb1567aabcea377f8a375380c32eae8dee..167c272d85286921075a172670bf4c60917fe9cb 100644 (file)
@@ -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<deal_II_dimension, deal_II_space_dimension> &);
-
-      template void
-      rotate<deal_II_dimension>(
-        const double,
-        const unsigned int,
-        Triangulation<deal_II_dimension, deal_II_space_dimension> &);
 #  endif
 
       template void
index 64bc907348fc4bcc91dd309a15f081545b2cb182..a6f1045e6024bf23f55e0aef179863c8ae6b959e 100644 (file)
@@ -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(
index 1ae650e2e17f44ade2dca03dc6d7866ac9dba421..d250df29f6fc67fe2e007deaf6991a677d7a0b98 100644 (file)
@@ -2181,15 +2181,6 @@ namespace Particles
 
 
 
-  template <int dim, int spacedim>
-  void
-  ParticleHandler<dim, spacedim>::register_store_callback_function()
-  {
-    register_data_attach();
-  }
-
-
-
   template <int dim, int spacedim>
   void
   ParticleHandler<dim, spacedim>::register_data_attach()
@@ -2228,16 +2219,6 @@ namespace Particles
   }
 
 
-  template <int dim, int spacedim>
-  void
-  ParticleHandler<dim, spacedim>::register_load_callback_function(
-    const bool serialization)
-  {
-    notify_ready_to_unpack(serialization);
-  }
-
-
-
   template <int dim, int spacedim>
   void
   ParticleHandler<dim, spacedim>::notify_ready_to_unpack(
diff --git a/tests/mpi/create_group_01.cc b/tests/mpi/create_group_01.cc
deleted file mode 100644 (file)
index 9387022..0000000
+++ /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<int> 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 (file)
index 3342d14..0000000
+++ /dev/null
@@ -1,8 +0,0 @@
-
-DEAL:0::OK
-
-DEAL:1::OK
-
-
-DEAL:2::OK
-
index 7f779028162f3bac43c6e4c894303a9e352c9e54..13369822ed133ff5ff6cbbb7cd30aeb55c391960 100644 (file)
@@ -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
index 728ee9cb306210af3b90d43ca0483cd2651cbca7..7e56ec94a07ebe144d7b0b3e8dd832e4e6892df0 100644 (file)
@@ -82,7 +82,7 @@ test()
     parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
 
     GridGenerator::hyper_cube(tr);
-    tr.load(filename.c_str(), false);
+    tr.load(filename.c_str());
 
     if (myid == 0)
       {
index a7c20387e02039c1146c7e737215dc0d7b3bb98d..cb273e2e8244d2db3edff238bf744af9f07120c9 100644 (file)
@@ -112,7 +112,7 @@ test()
     parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
 
     GridGenerator::hyper_cube(tr);
-    tr.load(filename.c_str(), false);
+    tr.load(filename.c_str());
     FE_Q<dim>       fe(1);
     DoFHandler<dim> dh(tr);
 
index 0ed17a462bbed30c33678953e4866bad0eafec28..0bea74f3ceb2864338528052f5f6a876d4458539 100644 (file)
@@ -124,7 +124,7 @@ test()
     parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
 
     GridGenerator::hyper_cube(tr);
-    tr.load(filename.c_str(), false);
+    tr.load(filename.c_str());
     FE_Q<dim>       fe(1);
     DoFHandler<dim> dh(tr);
 
index 6052713310302750d0b83445faf756db6ceb15aa..810c6d4dc8fbf05dc7c315320b50698f00ba688a 100644 (file)
@@ -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.
index a35fc8119ec25850afffb616961167eac5f072d8..6b3135913a5b1b565325a7e88fbfdf93004ae3df 100644 (file)
@@ -38,7 +38,7 @@ main()
 
   Vector<double> unrolled(9);
 
-  t.unroll(unrolled);
+  t.unroll(unrolled.data(), unrolled.data() + 9);
   deallog << "unrolled:";
   for (unsigned i = 0; i < 9; ++i)
     deallog << ' ' << unrolled(i);
index 6f0f1a9c7bd845d96c463441912ae9769c33f019..f2f6e2e7918d2af3770e8b966e073fb8e510cdc7 100644 (file)
@@ -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);
index ade4f2efb191a8862512de29f5ed397b6965e2e6..116a1286808c44dae709c784bb4d0b1218bc0eb7 100644 (file)
@@ -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<double>(unrolled(i));

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.