]> https://gitweb.dealii.org/ - dealii.git/commitdiff
includes: remove VTK header files
authorMatthias Maier <tamiko@43-1.org>
Wed, 28 Jun 2023 22:51:12 +0000 (17:51 -0500)
committerMatthias Maier <tamiko@43-1.org>
Wed, 28 Jun 2023 22:55:20 +0000 (17:55 -0500)
include/deal.II/base/config.h.in
include/deal.II/vtk/utilities.h [deleted file]

index 98ab0768ab9855136f36aae5cb11539060687d6d..1363bc13ed78c5b4f537885e19ed6af968718b3d 100644 (file)
@@ -70,7 +70,6 @@
 #cmakedefine DEAL_II_WITH_TRILINOS
 #cmakedefine DEAL_II_WITH_UMFPACK
 #cmakedefine DEAL_II_FEATURE_UMFPACK_BUNDLED_CONFIGURED
-#cmakedefine DEAL_II_WITH_VTK
 #cmakedefine DEAL_II_WITH_ZLIB
 
 #ifdef DEAL_II_WITH_TBB
diff --git a/include/deal.II/vtk/utilities.h b/include/deal.II/vtk/utilities.h
deleted file mode 100644 (file)
index 10b3162..0000000
+++ /dev/null
@@ -1,81 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2023 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE.md at
-// the top level directory of deal.II.
-//
-// ---------------------------------------------------------------------
-
-#ifndef dealii_vtk_utilities_h
-#define dealii_vtk_utilities_h
-
-#include <deal.II/base/config.h>
-
-#include <deal.II/base/exceptions.h>
-
-#ifdef DEAL_II_WITH_VTK
-
-#  include <vtkDoubleArray.h>
-
-DEAL_II_NAMESPACE_OPEN
-
-/**
- * Interface to the Visualization Toolkit (VTK).
- *
- * VTK is an open-source, freely available software system for 3D computer
- * graphics, modeling, image processing, volume rendering, scientific
- * visualization, and 2D plotting.
-
- * It supports a wide variety of visualization algorithms and advanced
- * modeling techniques, and it takes advantage of both threaded and distributed
- * memory parallel processing for speed and scalability, respectively.
- *
- * You can learn more about the VTK library at https://vtk.org/
- */
-namespace VTKWrappers
-{
-  /**
-   * Convert from a deal.II Point to a VTK double array.
-   *
-   * @tparam dim Dimension of the point
-   * @param [in] p An input deal.II Point<dim>
-   * @return A VTK smart pointer to the data array.
-   */
-  template <int dim>
-  inline vtkSmartPointer<vtkDoubleArray>
-  dealii_point_to_vtk_array(const dealii::Point<dim> &p);
-
-#  ifndef DOXYGEN
-  // Template implementations
-
-  template <int dim>
-  inline vtkSmartPointer<vtkDoubleArray>
-  dealii_point_to_vtk_array(const dealii::Point<dim> &p)
-  {
-    vtkSmartPointer<vtkDoubleArray> p_vtk =
-      vtkSmartPointer<vtkDoubleArray>::New();
-
-    p_vtk->SetNumberOfComponents(dim);
-    p_vtk->SetNumberOfTuples(1);
-
-    for (int d = 0; d < dim; ++d)
-      p_vtk->FillComponent(d, p[d]);
-
-    return p_vtk;
-  }
-
-#  endif
-
-} // namespace VTKWrappers
-
-DEAL_II_NAMESPACE_CLOSE
-
-#endif
-#endif

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.