]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Revert introduction of deprecated functions.
authorWolfgang Bangerth <bangerth@colostate.edu>
Thu, 6 Feb 2020 00:19:02 +0000 (17:19 -0700)
committerWolfgang Bangerth <bangerth@colostate.edu>
Thu, 6 Feb 2020 00:21:52 +0000 (17:21 -0700)
In #6830, @masterleinad introduced a whole bunch of functions that retained
backward compatibility for functions that @davydden had changed in #6818.
This was before the 9.1 release. It is time to remove these backward
compatibility functions again.

include/deal.II/base/data_out_base.h
source/base/data_out_base.cc
source/base/data_out_base.inst.in

index e17f86261b25f34b0702770b0635cc6ae8a7ec71..238a54ab20650c539a166d7b9d00508c47d9ac11 100644 (file)
@@ -1625,20 +1625,6 @@ namespace DataOutBase
     hdf5
   };
 
-  /**
-   * Write the given list of patches to the output stream in OpenDX format.
-   *
-   * @deprecated Use the version using DataComponentInterpretation instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  write_dx(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &            nonscalar_data_ranges,
-    const DXFlags &flags,
-    std::ostream & out);
 
   /**
    * Write the given list of patches to the output stream in OpenDX format.
@@ -1657,38 +1643,6 @@ namespace DataOutBase
     const DXFlags &flags,
     std::ostream & out);
 
-  /**
-   * Write the given list of patches to the output stream in eps format.
-   *
-   * @deprecated Use the version using DataComponentInterpretation instead.
-   */
-  template <int spacedim>
-  DEAL_II_DEPRECATED void
-  write_eps(
-    const std::vector<Patch<2, spacedim>> &patches,
-    const std::vector<std::string> &       data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &             nonscalar_data_ranges,
-    const EpsFlags &flags,
-    std::ostream &  out);
-
-  /**
-   * This is the same function as above except for domains that are not two-
-   * dimensional. This function is not implemented (and will throw an error if
-   * called) but is declared to allow for dimension-independent programs.
-   *
-   * @deprecated Use the version using DataComponentInterpretation instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  write_eps(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &             nonscalar_data_ranges,
-    const EpsFlags &flags,
-    std::ostream &  out);
-
   /**
    * Write the given list of patches to the output stream in eps format.
    *
@@ -1747,23 +1701,6 @@ namespace DataOutBase
     const EpsFlags &flags,
     std::ostream &  out);
 
-  /**
-   * This is the same function as above except for domains that are not two-
-   * dimensional. This function is not implemented (and will throw an error if
-   * called) but is declared to allow for dimension-independent programs.
-   *
-   * @deprecated Use the version using DataComponentInterpretation instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  write_eps(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &             nonscalar_data_ranges,
-    const EpsFlags &flags,
-    std::ostream &  out);
-
   /**
    * This is the same function as above except for domains that are not two-
    * dimensional. This function is not implemented (and will throw an error if
@@ -1783,20 +1720,6 @@ namespace DataOutBase
     const EpsFlags &flags,
     std::ostream &  out);
 
-  /**
-   * Write the given list of patches to the output stream in GMV format.
-   *
-   *@deprecated Use the version using DataComponentInterpretation instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  write_gmv(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &             nonscalar_data_ranges,
-    const GmvFlags &flags,
-    std::ostream &  out);
 
   /**
    * Write the given list of patches to the output stream in GMV format.
@@ -1821,21 +1744,6 @@ namespace DataOutBase
     const GmvFlags &flags,
     std::ostream &  out);
 
-  /**
-   * Write the given list of patches to the output stream in gnuplot format.
-   *
-   * @deprecated Use the version using DataComponentInterpretation instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  write_gnuplot(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &                 nonscalar_data_ranges,
-    const GnuplotFlags &flags,
-    std::ostream &      out);
-
   /**
    * Write the given list of patches to the output stream in gnuplot format.
    * Visualization of two-dimensional data can then be achieved by starting
@@ -1906,22 +1814,6 @@ namespace DataOutBase
     const GnuplotFlags &flags,
     std::ostream &      out);
 
-  /**
-   * Write the given list of patches to the output stream for the Povray
-   * raytracer.
-   *
-   *@deprecated Use the version using DataComponentInterpretation instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  write_povray(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &                nonscalar_data_ranges,
-    const PovrayFlags &flags,
-    std::ostream &     out);
-
   /**
    * Write the given list of patches to the output stream for the Povray
    * raytracer.
@@ -1981,24 +1873,6 @@ namespace DataOutBase
     const PovrayFlags &flags,
     std::ostream &     out);
 
-  /**
-   * Write the given list of patches to the output stream in Tecplot ASCII
-   * format (FEBLOCK).
-   *
-   * For more information consult the Tecplot Users and Reference manuals.
-   *
-   * @deprecated Use the version using DataComponentInterpretation instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  write_tecplot(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &                 nonscalar_data_ranges,
-    const TecplotFlags &flags,
-    std::ostream &      out);
-
   /**
    * Write the given list of patches to the output stream in Tecplot ASCII
    * format (FEBLOCK).
@@ -2019,22 +1893,6 @@ namespace DataOutBase
     const TecplotFlags &flags,
     std::ostream &      out);
 
-  /**
-   * Write the given list of patches to the output stream in Tecplot binary
-   * format.
-   *
-   * @deprecated Using Tecplot binary output is deprecated.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  write_tecplot_binary(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &                 nonscalar_data_ranges,
-    const TecplotFlags &flags,
-    std::ostream &      out);
-
   /**
    * Write the given list of patches to the output stream in Tecplot binary
    * format.
@@ -2070,22 +1928,6 @@ namespace DataOutBase
     const TecplotFlags &flags,
     std::ostream &      out);
 
-  /**
-   * Write the given list of patches to the output stream in UCD format
-   * described in the AVS developer's guide (now AVS).
-   *
-   * @deprecated Use the version using DataComponentInterpretation instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  write_ucd(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &             nonscalar_data_ranges,
-    const UcdFlags &flags,
-    std::ostream &  out);
-
   /**
    * Write the given list of patches to the output stream in UCD format
    * described in the AVS developer's guide (now AVS). Due to limitations in
@@ -2114,23 +1956,6 @@ namespace DataOutBase
     const UcdFlags &flags,
     std::ostream &  out);
 
-  /**
-   * Write the given list of patches to the output stream in VTK format. The
-   * data is written in the traditional VTK format as opposed to the XML-based
-   * format that write_vtu() produces.
-   *
-   * @deprecated Use the version using DataComponentInterpretation instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  write_vtk(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &             nonscalar_data_ranges,
-    const VtkFlags &flags,
-    std::ostream &  out);
-
   /**
    * Write the given list of patches to the output stream in VTK format. The
    * data is written in the traditional VTK format as opposed to the XML-based
@@ -2164,22 +1989,6 @@ namespace DataOutBase
     const VtkFlags &flags,
     std::ostream &  out);
 
-  /**
-   * Write the given list of patches to the output stream in VTU format. The
-   * data is written in the XML-based VTK format as opposed to the traditional
-   * format that write_vtk() produces.
-   *
-   * @deprecated Use the version using DataComponentInterpretation instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  write_vtu(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &             nonscalar_data_ranges,
-    const VtkFlags &flags,
-    std::ostream &  out);
 
   /**
    * Write the given list of patches to the output stream in VTU format. The
@@ -2235,24 +2044,6 @@ namespace DataOutBase
   void
   write_vtu_footer(std::ostream &out);
 
-  /**
-   * This function writes the main part for the xml based vtu file format. This
-   * routine is used internally together with
-   * DataOutInterface::write_vtu_header() and
-   * DataOutInterface::write_vtu_footer() by DataOutBase::write_vtu().
-   *
-   * @deprecated Use the version using DataComponentInterpretation instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  write_vtu_main(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &             nonscalar_data_ranges,
-    const VtkFlags &flags,
-    std::ostream &  out);
-
   /**
    * This function writes the main part for the xml based vtu file format. This
    * routine is used internally together with
@@ -2273,25 +2064,6 @@ namespace DataOutBase
     const VtkFlags &flags,
     std::ostream &  out);
 
-  /**
-   * Some visualization programs, such as ParaView, can read several separate
-   * VTU files that all form part of the same simulation, in order to
-   * parallelize visualization. In that case, you need a
-   * <code>.pvtu</code> file that describes which VTU files (written, for
-   * example, through the DataOutInterface::write_vtu() function) form a group.
-   * The current function can generate such a master record.
-   *
-   * @deprecated Use the version using DataComponentInterpretation instead.
-   */
-  DEAL_II_DEPRECATED
-  void
-  write_pvtu_record(
-    std::ostream &                  out,
-    const std::vector<std::string> &piece_names,
-    const std::vector<std::string> &data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &nonscalar_data_ranges);
-
   /**
    * Some visualization programs, such as ParaView, can read several separate
    * VTU files that all form part of the same simulation, in order to
@@ -2484,21 +2256,6 @@ namespace DataOutBase
     const std::vector<std::pair<double, std::vector<std::string>>>
       &times_and_piece_names);
 
-  /**
-   * Write the given list of patches to the output stream in SVG format.
-   *
-   * @deprecated Use the version using DataComponentInterpretation instead.
-   */
-  template <int spacedim>
-  DEAL_II_DEPRECATED void
-  write_svg(
-    const std::vector<Patch<2, spacedim>> &patches,
-    const std::vector<std::string> &       data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &             nonscalar_data_ranges,
-    const SvgFlags &flags,
-    std::ostream &  out);
-
   /**
    * Write the given list of patches to the output stream in SVG format.
    *
@@ -2533,27 +2290,6 @@ namespace DataOutBase
     const SvgFlags &flags,
     std::ostream &  out);
 
-  /**
-   * Write the given list of patches to the output stream in deal.II
-   * intermediate format. This is not a format understood by any other
-   * graphics program, but is rather a direct dump of the intermediate
-   * internal format used by deal.II. This internal format is generated by the
-   * various classes that can generate output using the DataOutBase class, for
-   * example from a finite element solution, and is then converted in the
-   * present class to the final graphics format.
-   *
-   * @deprecated Use the version using DataComponentInterpretation instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  write_deal_II_intermediate(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &                              nonscalar_data_ranges,
-    const Deal_II_IntermediateFlags &flags,
-    std::ostream &                   out);
-
   /**
    * Write the given list of patches to the output stream in deal.II
    * intermediate format. This is not a format understood by any other
@@ -2632,23 +2368,6 @@ namespace DataOutBase
                       const std::string &solution_filename,
                       MPI_Comm           comm);
 
-  /**
-   * DataOutFilter is an intermediate data format that reduces the amount of
-   * data that will be written to files. The object filled by this function
-   * can then later be used again to write data in a concrete file format;
-   * see, for example, DataOutBase::write_hdf5_parallel().
-   *
-   * @deprecated Use the version using DataComponentInterpretation instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  write_filtered_data(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &            nonscalar_data_ranges,
-    DataOutFilter &filtered_data);
-
   /**
    * DataOutFilter is an intermediate data format that reduces the amount of
    * data that will be written to files. The object filled by this function
@@ -3306,17 +3025,6 @@ protected:
   virtual std::vector<std::string>
   get_dataset_names() const = 0;
 
-  /**
-   * This functions returns information about how the individual components of
-   * output files that consist of more than one data set are to be
-   * interpreted.
-   *
-   * @deprecated Use get_nonscalar_data_ranges instead.
-   */
-  DEAL_II_DEPRECATED
-  virtual std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-  get_vector_data_ranges() const;
-
   /**
    * This functions returns information about how the individual components of
    * output files that consist of more than one data set are to be
index 8612c0ea376ac12e99f243b848dbe22dee935a20..c96dd5c902890d76b3fbac5ebdb658ff26f10936 100644 (file)
@@ -2977,29 +2977,6 @@ namespace DataOutBase
 
 
 
-  template <int dim, int spacedim>
-  void
-  write_ucd(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>> &,
-    const UcdFlags &flags,
-    std::ostream &  out)
-  {
-    write_ucd(
-      patches,
-      data_names,
-      std::vector<
-        std::tuple<unsigned int,
-                   unsigned int,
-                   std::string,
-                   DataComponentInterpretation::DataComponentInterpretation>>{},
-      flags,
-      out);
-  }
-
-
-
   template <int dim, int spacedim>
   void
   write_ucd(
@@ -3091,30 +3068,6 @@ namespace DataOutBase
   }
 
 
-
-  template <int dim, int spacedim>
-  void
-  write_dx(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>> &,
-    const DXFlags &flags,
-    std::ostream & out)
-  {
-    write_dx(
-      patches,
-      data_names,
-      std::vector<
-        std::tuple<unsigned int,
-                   unsigned int,
-                   std::string,
-                   DataComponentInterpretation::DataComponentInterpretation>>{},
-      flags,
-      out);
-  }
-
-
-
   template <int dim, int spacedim>
   void
   write_dx(
@@ -3398,29 +3351,6 @@ namespace DataOutBase
 
 
 
-  template <int dim, int spacedim>
-  void
-  write_gnuplot(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>> &,
-    const GnuplotFlags &flags,
-    std::ostream &      out)
-  {
-    write_gnuplot(
-      patches,
-      data_names,
-      std::vector<
-        std::tuple<unsigned int,
-                   unsigned int,
-                   std::string,
-                   DataComponentInterpretation::DataComponentInterpretation>>{},
-      flags,
-      out);
-  }
-
-
-
   template <int dim, int spacedim>
   void
   write_gnuplot(
@@ -3628,29 +3558,6 @@ namespace DataOutBase
 
 
 
-  template <int dim, int spacedim>
-  void
-  write_povray(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>> &,
-    const PovrayFlags &flags,
-    std::ostream &     out)
-  {
-    write_povray(
-      patches,
-      data_names,
-      std::vector<
-        std::tuple<unsigned int,
-                   unsigned int,
-                   std::string,
-                   DataComponentInterpretation::DataComponentInterpretation>>{},
-      flags,
-      out);
-  }
-
-
-
   template <int dim, int spacedim>
   void
   write_povray(
@@ -3978,21 +3885,6 @@ namespace DataOutBase
 
 
 
-  template <int dim, int spacedim>
-  void
-  write_eps(
-    const std::vector<Patch<dim, spacedim>> & /*patches*/,
-    const std::vector<std::string> & /*data_names*/,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>> &,
-    const EpsFlags & /*flags*/,
-    std::ostream & /*out*/)
-  {
-    // not implemented, see the documentation of the function
-    AssertThrow(dim == 2, ExcNotImplemented());
-  }
-
-
-
   template <int dim, int spacedim>
   void
   write_eps(
@@ -4011,30 +3903,6 @@ namespace DataOutBase
   }
 
 
-
-  template <int spacedim>
-  void
-  write_eps(
-    const std::vector<Patch<2, spacedim>> &patches,
-    const std::vector<std::string> &       data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>> &,
-    const EpsFlags &flags,
-    std::ostream &  out)
-  {
-    write_eps(
-      patches,
-      data_names,
-      std::vector<
-        std::tuple<unsigned int,
-                   unsigned int,
-                   std::string,
-                   DataComponentInterpretation::DataComponentInterpretation>>{},
-      flags,
-      out);
-  }
-
-
-
   template <int spacedim>
   void
   write_eps(
@@ -4349,29 +4217,6 @@ namespace DataOutBase
 
 
 
-  template <int dim, int spacedim>
-  void
-  write_gmv(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>> &,
-    const GmvFlags &flags,
-    std::ostream &  out)
-  {
-    write_gmv(
-      patches,
-      data_names,
-      std::vector<
-        std::tuple<unsigned int,
-                   unsigned int,
-                   std::string,
-                   DataComponentInterpretation::DataComponentInterpretation>>{},
-      flags,
-      out);
-  }
-
-
-
   template <int dim, int spacedim>
   void
   write_gmv(
@@ -4509,29 +4354,6 @@ namespace DataOutBase
 
 
 
-  template <int dim, int spacedim>
-  void
-  write_tecplot(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>> &,
-    const TecplotFlags &flags,
-    std::ostream &      out)
-  {
-    write_tecplot(
-      patches,
-      data_names,
-      std::vector<
-        std::tuple<unsigned int,
-                   unsigned int,
-                   std::string,
-                   DataComponentInterpretation::DataComponentInterpretation>>{},
-      flags,
-      out);
-  }
-
-
-
   template <int dim, int spacedim>
   void
   write_tecplot(
@@ -4763,42 +4585,6 @@ namespace DataOutBase
 
 
 
-  template <int dim, int spacedim>
-  void
-  write_tecplot_binary(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &                 nonscalar_data_ranges,
-    const TecplotFlags &flags,
-    std::ostream &      out)
-  {
-    const unsigned int size = nonscalar_data_ranges.size();
-    std::vector<
-      std::tuple<unsigned int,
-                 unsigned int,
-                 std::string,
-                 DataComponentInterpretation::DataComponentInterpretation>>
-      new_nonscalar_data_ranges(size);
-    for (unsigned int i = 0; i < size; ++i)
-      {
-        new_nonscalar_data_ranges[i] =
-          std::tuple<unsigned int,
-                     unsigned int,
-                     std::string,
-                     DataComponentInterpretation::DataComponentInterpretation>(
-            std::get<0>(nonscalar_data_ranges[i]),
-            std::get<1>(nonscalar_data_ranges[i]),
-            std::get<2>(nonscalar_data_ranges[i]),
-            DataComponentInterpretation::component_is_part_of_vector);
-      }
-
-    write_tecplot_binary(
-      patches, data_names, new_nonscalar_data_ranges, flags, out);
-  }
-
-
-
   template <int dim, int spacedim>
   void
   write_tecplot_binary(
@@ -5124,41 +4910,6 @@ namespace DataOutBase
 
 
 
-  template <int dim, int spacedim>
-  void
-  write_vtk(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &             nonscalar_data_ranges,
-    const VtkFlags &flags,
-    std::ostream &  out)
-  {
-    const unsigned int size = nonscalar_data_ranges.size();
-    std::vector<
-      std::tuple<unsigned int,
-                 unsigned int,
-                 std::string,
-                 DataComponentInterpretation::DataComponentInterpretation>>
-      new_nonscalar_data_ranges(size);
-    for (unsigned int i = 0; i < size; ++i)
-      {
-        new_nonscalar_data_ranges[i] =
-          std::tuple<unsigned int,
-                     unsigned int,
-                     std::string,
-                     DataComponentInterpretation::DataComponentInterpretation>(
-            std::get<0>(nonscalar_data_ranges[i]),
-            std::get<1>(nonscalar_data_ranges[i]),
-            std::get<2>(nonscalar_data_ranges[i]),
-            DataComponentInterpretation::component_is_part_of_vector);
-      }
-
-    write_vtk(patches, data_names, new_nonscalar_data_ranges, flags, out);
-  }
-
-
-
   template <int dim, int spacedim>
   void
   write_vtk(
@@ -5454,25 +5205,6 @@ namespace DataOutBase
 
 
 
-  template <int dim, int spacedim>
-  void
-  write_vtu(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &             nonscalar_data_ranges,
-    const VtkFlags &flags,
-    std::ostream &  out)
-  {
-    write_vtu_header(out, flags);
-    write_vtu_main(patches, data_names, nonscalar_data_ranges, flags, out);
-    write_vtu_footer(out);
-
-    out << std::flush;
-  }
-
-
-
   template <int dim, int spacedim>
   void
   write_vtu(
@@ -5495,42 +5227,6 @@ namespace DataOutBase
   }
 
 
-
-  template <int dim, int spacedim>
-  void
-  write_vtu_main(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &             nonscalar_data_ranges,
-    const VtkFlags &flags,
-    std::ostream &  out)
-  {
-    const unsigned int size = nonscalar_data_ranges.size();
-    std::vector<
-      std::tuple<unsigned int,
-                 unsigned int,
-                 std::string,
-                 DataComponentInterpretation::DataComponentInterpretation>>
-      new_nonscalar_data_ranges(size);
-    for (unsigned int i = 0; i < size; ++i)
-      {
-        new_nonscalar_data_ranges[i] =
-          std::tuple<unsigned int,
-                     unsigned int,
-                     std::string,
-                     DataComponentInterpretation::DataComponentInterpretation>(
-            std::get<0>(nonscalar_data_ranges[i]),
-            std::get<1>(nonscalar_data_ranges[i]),
-            std::get<2>(nonscalar_data_ranges[i]),
-            DataComponentInterpretation::component_is_part_of_vector);
-      }
-
-    write_vtu_main(patches, data_names, new_nonscalar_data_ranges, flags, out);
-  }
-
-
-
   template <int dim, int spacedim>
   void
   write_vtu_main(
@@ -5924,39 +5620,6 @@ namespace DataOutBase
 
 
 
-  void
-  write_pvtu_record(
-    std::ostream &                  out,
-    const std::vector<std::string> &piece_names,
-    const std::vector<std::string> &data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &nonscalar_data_ranges)
-  {
-    const unsigned int size = nonscalar_data_ranges.size();
-    std::vector<
-      std::tuple<unsigned int,
-                 unsigned int,
-                 std::string,
-                 DataComponentInterpretation::DataComponentInterpretation>>
-      new_nonscalar_data_ranges(size);
-    for (unsigned int i = 0; i < size; ++i)
-      {
-        new_nonscalar_data_ranges[i] =
-          std::tuple<unsigned int,
-                     unsigned int,
-                     std::string,
-                     DataComponentInterpretation::DataComponentInterpretation>(
-            std::get<0>(nonscalar_data_ranges[i]),
-            std::get<1>(nonscalar_data_ranges[i]),
-            std::get<2>(nonscalar_data_ranges[i]),
-            DataComponentInterpretation::component_is_part_of_vector);
-      }
-
-    write_pvtu_record(out, piece_names, data_names, new_nonscalar_data_ranges);
-  }
-
-
-
   void
   write_pvtu_record(
     std::ostream &                  out,
@@ -6179,20 +5842,6 @@ namespace DataOutBase
 
 
 
-  template <int dim, int spacedim>
-  void
-  write_svg(
-    const std::vector<Patch<dim, spacedim>> &,
-    const std::vector<std::string> &,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>> &,
-    const SvgFlags &,
-    std::ostream &)
-  {
-    Assert(false, ExcNotImplemented());
-  }
-
-
-
   template <int dim, int spacedim>
   void
   write_svg(
@@ -6209,32 +5858,6 @@ namespace DataOutBase
     Assert(false, ExcNotImplemented());
   }
 
-
-
-  template <int spacedim>
-  void
-  write_svg(
-    const std::vector<Patch<2, spacedim>> &patches,
-    const std::vector<std::string> &       data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>> &
-    /*nonscalar_data_ranges*/,
-    const SvgFlags &flags,
-    std::ostream &  out)
-  {
-    write_svg(
-      patches,
-      data_names,
-      std::vector<
-        std::tuple<unsigned int,
-                   unsigned int,
-                   std::string,
-                   DataComponentInterpretation::DataComponentInterpretation>>{},
-      flags,
-      out);
-  }
-
-
-
   template <int spacedim>
   void
   write_svg(
@@ -7194,42 +6817,6 @@ namespace DataOutBase
 
 
 
-  template <int dim, int spacedim>
-  void
-  write_deal_II_intermediate(
-    const std::vector<Patch<dim, spacedim>> &patches,
-    const std::vector<std::string> &         data_names,
-    const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-      &                              nonscalar_data_ranges,
-    const Deal_II_IntermediateFlags &flags,
-    std::ostream &                   out)
-  {
-    const unsigned int size = nonscalar_data_ranges.size();
-    std::vector<
-      std::tuple<unsigned int,
-                 unsigned int,
-                 std::string,
-                 DataComponentInterpretation::DataComponentInterpretation>>
-      new_nonscalar_data_ranges(size);
-    for (unsigned int i = 0; i < size; ++i)
-      {
-        new_nonscalar_data_ranges[i] =
-          std::tuple<unsigned int,
-                     unsigned int,
-                     std::string,
-                     DataComponentInterpretation::DataComponentInterpretation>(
-            std::get<0>(nonscalar_data_ranges[i]),
-            std::get<1>(nonscalar_data_ranges[i]),
-            std::get<2>(nonscalar_data_ranges[i]),
-            DataComponentInterpretation::component_is_part_of_vector);
-      }
-
-    write_deal_II_intermediate(
-      patches, data_names, new_nonscalar_data_ranges, flags, out);
-  }
-
-
-
   template <int dim, int spacedim>
   void
   write_deal_II_intermediate(
@@ -7795,43 +7382,6 @@ DataOutInterface<dim, spacedim>::write_filtered_data(
 
 
 
-template <int dim, int spacedim>
-void
-DataOutBase::write_filtered_data(
-  const std::vector<Patch<dim, spacedim>> &patches,
-  const std::vector<std::string> &         data_names,
-  const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-    &                         nonscalar_data_ranges,
-  DataOutBase::DataOutFilter &filtered_data)
-{
-  const unsigned int size = nonscalar_data_ranges.size();
-  std::vector<
-    std::tuple<unsigned int,
-               unsigned int,
-               std::string,
-               DataComponentInterpretation::DataComponentInterpretation>>
-    new_nonscalar_data_ranges(size);
-  for (unsigned int i = 0; i < size; ++i)
-    {
-      new_nonscalar_data_ranges[i] =
-        std::tuple<unsigned int,
-                   unsigned int,
-                   std::string,
-                   DataComponentInterpretation::DataComponentInterpretation>(
-          std::get<0>(nonscalar_data_ranges[i]),
-          std::get<1>(nonscalar_data_ranges[i]),
-          std::get<2>(nonscalar_data_ranges[i]),
-          DataComponentInterpretation::component_is_part_of_vector);
-    }
-
-  DataOutBase::write_filtered_data(patches,
-                                   data_names,
-                                   new_nonscalar_data_ranges,
-                                   filtered_data);
-}
-
-
-
 template <int dim, int spacedim>
 void
 DataOutBase::write_filtered_data(
@@ -8612,29 +8162,6 @@ DataOutInterface<dim, spacedim>::get_nonscalar_data_ranges() const
 }
 
 
-
-template <int dim, int spacedim>
-std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-DataOutInterface<dim, spacedim>::get_vector_data_ranges() const
-{
-  const auto &nonscalar_data_ranges = get_nonscalar_data_ranges();
-
-  const unsigned int size = nonscalar_data_ranges.size();
-  std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-    vector_data_ranges(size);
-  for (unsigned int i = 0; i < size; ++i)
-    {
-      vector_data_ranges[i] =
-        std::tuple<unsigned int, unsigned int, std::string>(
-          std::get<0>(nonscalar_data_ranges[i]),
-          std::get<1>(nonscalar_data_ranges[i]),
-          std::get<2>(nonscalar_data_ranges[i]));
-    }
-  return vector_data_ranges;
-}
-
-
-
 template <int dim, int spacedim>
 void
 DataOutInterface<dim, spacedim>::validate_dataset_names() const
index fec6c5a1b46f64e6a5fdb33816ddf03d723d9d34..c06056170280f334778a94595a5d86921c849639 100644 (file)
@@ -34,16 +34,6 @@ for (deal_II_dimension : OUTPUT_DIMENSIONS;
       operator>>(std::istream &                                     in,
                  Patch<deal_II_dimension, deal_II_space_dimension> &patch);
 
-      template void
-      write_vtk(
-        const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
-          &                             patches,
-        const std::vector<std::string> &data_names,
-        const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-          &             nonscalar_data_ranges,
-        const VtkFlags &flags,
-        std::ostream &  out);
-
       template void
       write_vtk(
         const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
@@ -58,16 +48,6 @@ for (deal_II_dimension : OUTPUT_DIMENSIONS;
         const VtkFlags &flags,
         std::ostream &  out);
 
-      template void
-      write_vtu(
-        const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
-          &                             patches,
-        const std::vector<std::string> &data_names,
-        const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-          &             nonscalar_data_ranges,
-        const VtkFlags &flags,
-        std::ostream &  out);
-
       template void
       write_vtu(
         const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
@@ -82,16 +62,6 @@ for (deal_II_dimension : OUTPUT_DIMENSIONS;
         const VtkFlags &flags,
         std::ostream &  out);
 
-      template void
-      write_ucd(
-        const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
-          &                             patches,
-        const std::vector<std::string> &data_names,
-        const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-          &             nonscalar_data_ranges,
-        const UcdFlags &flags,
-        std::ostream &  out);
-
       template void
       write_ucd(
         const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
@@ -106,16 +76,6 @@ for (deal_II_dimension : OUTPUT_DIMENSIONS;
         const UcdFlags &flags,
         std::ostream &  out);
 
-      template void
-      write_dx(
-        const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
-          &                             patches,
-        const std::vector<std::string> &data_names,
-        const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-          &            nonscalar_data_ranges,
-        const DXFlags &flags,
-        std::ostream & out);
-
       template void
       write_dx(
         const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
@@ -130,16 +90,6 @@ for (deal_II_dimension : OUTPUT_DIMENSIONS;
         const DXFlags &flags,
         std::ostream & out);
 
-      template void
-      write_gnuplot(
-        const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
-          &                             patches,
-        const std::vector<std::string> &data_names,
-        const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-          &                 nonscalar_data_ranges,
-        const GnuplotFlags &flags,
-        std::ostream &      out);
-
       template void
       write_gnuplot(
         const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
@@ -154,16 +104,6 @@ for (deal_II_dimension : OUTPUT_DIMENSIONS;
         const GnuplotFlags &flags,
         std::ostream &      out);
 
-      template void
-      write_povray(
-        const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
-          &                             patches,
-        const std::vector<std::string> &data_names,
-        const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-          &                nonscalar_data_ranges,
-        const PovrayFlags &flags,
-        std::ostream &     out);
-
       template void
       write_povray(
         const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
@@ -178,16 +118,6 @@ for (deal_II_dimension : OUTPUT_DIMENSIONS;
         const PovrayFlags &flags,
         std::ostream &     out);
 
-      template void
-      write_eps(
-        const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
-          &                             patches,
-        const std::vector<std::string> &data_names,
-        const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-          &             nonscalar_data_ranges,
-        const EpsFlags &flags,
-        std::ostream &  out);
-
       template void
       write_eps(
         const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
@@ -202,16 +132,6 @@ for (deal_II_dimension : OUTPUT_DIMENSIONS;
         const EpsFlags &flags,
         std::ostream &  out);
 
-      template void
-      write_gmv(
-        const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
-          &                             patches,
-        const std::vector<std::string> &data_names,
-        const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-          &             nonscalar_data_ranges,
-        const GmvFlags &flags,
-        std::ostream &  out);
-
       template void
       write_gmv(
         const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
@@ -226,16 +146,6 @@ for (deal_II_dimension : OUTPUT_DIMENSIONS;
         const GmvFlags &flags,
         std::ostream &  out);
 
-      template void
-      write_tecplot(
-        const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
-          &                             patches,
-        const std::vector<std::string> &data_names,
-        const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-          &                 nonscalar_data_ranges,
-        const TecplotFlags &flags,
-        std::ostream &      out);
-
       template void
       write_tecplot(
         const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
@@ -250,16 +160,6 @@ for (deal_II_dimension : OUTPUT_DIMENSIONS;
         const TecplotFlags &flags,
         std::ostream &      out);
 
-      template void
-      write_tecplot_binary(
-        const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
-          &                             patches,
-        const std::vector<std::string> &data_names,
-        const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-          &                 nonscalar_data_ranges,
-        const TecplotFlags &flags,
-        std::ostream &      out);
-
       template void
       write_tecplot_binary(
         const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
@@ -275,16 +175,6 @@ for (deal_II_dimension : OUTPUT_DIMENSIONS;
         std::ostream &      out);
 
 #  if deal_II_space_dimension > 1
-      template void
-      write_svg(
-        const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
-          &                             patches,
-        const std::vector<std::string> &data_names,
-        const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-          &             nonscalar_data_ranges,
-        const SvgFlags &flags,
-        std::ostream &  out);
-
       template void
       write_svg(
         const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
@@ -299,17 +189,6 @@ for (deal_II_dimension : OUTPUT_DIMENSIONS;
         const SvgFlags &flags,
         std::ostream &  out);
 #  endif
-
-      template void
-      write_deal_II_intermediate(
-        const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
-          &                             patches,
-        const std::vector<std::string> &data_names,
-        const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-          &                              nonscalar_data_ranges,
-        const Deal_II_IntermediateFlags &flags,
-        std::ostream &                   out);
-
       template void
       write_deal_II_intermediate(
         const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>>
@@ -332,14 +211,6 @@ for (deal_II_dimension : OUTPUT_DIMENSIONS;
         const std::string &  filename,
         MPI_Comm             comm);
 
-      template void
-      write_filtered_data(
-        const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>> &,
-        const std::vector<std::string> &,
-        const std::vector<std::tuple<unsigned int, unsigned int, std::string>>
-          &,
-        DataOutBase::DataOutFilter &);
-
       template void
       write_filtered_data(
         const std::vector<Patch<deal_II_dimension, deal_II_space_dimension>> &,

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.