]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove deprecated function DataOutBase::write_hdf5_parallel.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Fri, 2 Jan 2015 19:06:55 +0000 (13:06 -0600)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Sun, 4 Jan 2015 21:13:47 +0000 (15:13 -0600)
doc/news/changes.h
include/deal.II/base/data_out_base.h
source/base/data_out_base.cc

index 4df445fbee10c1e2a526c808e56097c19cc58aa8..8f96e3cb8a518d9987fdc901dee3dc4b00412d6d 100644 (file)
@@ -59,6 +59,7 @@ inconvenience this causes.
   - The version of GridGenerator::parallelogram where the corners are given
     as a rank-2 tensor rather than as an array of points.
   - DataOutBase::create_xdmf_entry with 3 arguments.
+  - DataOutBase::write_hdf5_parallel with 2 arguments.
   - Algorithms::ThetaTimestepping::operator().
   - Algorithms::ThetaTimestepping::initialize.
   - Algorithms::Newton::initialize.
index 6441fce9aa6e7abdde05d7425adb595396004bcb..308f2e692a588ce6d4ccb3425b8df521668aaffe 100644 (file)
@@ -2363,14 +2363,6 @@ public:
                         const std::string &filename,
                         MPI_Comm comm) const;
 
-  /**
-   * Write the data in this class without redundancy filtering to a single
-   * HDF5 file containing both the mesh and solution values.
-   * @deprecated: use write_hdf5_parallel(DataOutFilter, ...) instead
-   */
-  void write_hdf5_parallel (const std::string &filename,
-                            MPI_Comm comm) const DEAL_II_DEPRECATED;
-
   /**
    * Write the data in data_filter to a single HDF5 file containing both the
    * mesh and solution values. Below is an example of how to use this function
@@ -2385,7 +2377,8 @@ public:
    * @endcode
    */
   void write_hdf5_parallel (const DataOutBase::DataOutFilter &data_filter,
-                            const std::string &filename, MPI_Comm comm) const;
+                            const std::string &filename,
+                            MPI_Comm comm) const;
 
   /**
    * Write the data in data_filter to HDF5 file(s). If write_mesh_file is
@@ -2395,7 +2388,10 @@ public:
    * and solution values.
    */
   void write_hdf5_parallel (const DataOutBase::DataOutFilter &data_filter,
-                            const bool write_mesh_file, const std::string &mesh_filename, const std::string &solution_filename, MPI_Comm comm) const;
+                            const bool write_mesh_file,
+                            const std::string &mesh_filename,
+                            const std::string &solution_filename,
+                            MPI_Comm comm) const;
 
   /**
    * DataOutFilter is an intermediate data format that reduces the amount of
index 18027630721c15117e6d0749454045b8152f2082..fde2d4eb7a1adb0170e15dc9c28a0d1071f8a1eb 100644 (file)
@@ -7143,14 +7143,7 @@ void DataOutBase::write_filtered_data (const std::vector<Patch<dim,spacedim> > &
     }
 }
 
-template <int dim, int spacedim>
-void DataOutInterface<dim,spacedim>::
-write_hdf5_parallel (const std::string &filename, MPI_Comm comm) const
-{
-  DataOutBase::DataOutFilter  data_filter(DataOutBase::DataOutFilterFlags(false, true));
-  write_filtered_data(data_filter);
-  write_hdf5_parallel(data_filter, filename, comm);
-}
+
 
 template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::
@@ -7160,6 +7153,8 @@ write_hdf5_parallel (const DataOutBase::DataOutFilter &data_filter,
   DataOutBase::write_hdf5_parallel(get_patches(), data_filter, filename, comm);
 }
 
+
+
 template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::
 write_hdf5_parallel (const DataOutBase::DataOutFilter &data_filter,
@@ -7168,6 +7163,8 @@ write_hdf5_parallel (const DataOutBase::DataOutFilter &data_filter,
   DataOutBase::write_hdf5_parallel(get_patches(), data_filter, write_mesh_file, mesh_filename, solution_filename, comm);
 }
 
+
+
 template <int dim, int spacedim>
 void DataOutBase::write_hdf5_parallel (const std::vector<Patch<dim,spacedim> > &patches,
                                        const DataOutBase::DataOutFilter &data_filter,
@@ -7177,6 +7174,8 @@ void DataOutBase::write_hdf5_parallel (const std::vector<Patch<dim,spacedim> > &
   write_hdf5_parallel(patches, data_filter, true, filename, filename, comm);
 }
 
+
+
 template <int dim, int spacedim>
 void DataOutBase::write_hdf5_parallel (const std::vector<Patch<dim,spacedim> > &patches,
                                        const DataOutBase::DataOutFilter &data_filter,

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.