]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove deprecated header file 6584/head
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sat, 12 May 2018 23:19:23 +0000 (01:19 +0200)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sun, 13 May 2018 00:14:22 +0000 (02:14 +0200)
include/deal.II/base/tensor_base.h [deleted file]
include/deal.II/distributed/grid_tools.h [deleted file]
include/deal.II/lac/petsc_compatibility.h
include/deal.II/lac/trilinos_vector_base.h [deleted file]
include/deal.II/multigrid/mg_dof_accessor.h [deleted file]
tests/grid/grid_tools_compute_mesh_predicate_bounding_box_1.cc

diff --git a/include/deal.II/base/tensor_base.h b/include/deal.II/base/tensor_base.h
deleted file mode 100644 (file)
index 0287562..0000000
+++ /dev/null
@@ -1,7 +0,0 @@
-#ifndef dealii_tensor_base_h
-#define dealii_tensor_base_h
-#warning This file is deprecated. Use <deal.II/base/tensor.h> instead.
-
-#  include <deal.II/base/tensor.h>
-
-#endif
diff --git a/include/deal.II/distributed/grid_tools.h b/include/deal.II/distributed/grid_tools.h
deleted file mode 100644 (file)
index ca8d1d3..0000000
+++ /dev/null
@@ -1,23 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2017 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 at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-#ifndef dealii_distributed_grid_tools_h
-#define dealii_distributed_grid_tools_h
-
-#warning "This file is deprecated and will be removed after the 9.0 release. Use <deal.II/grid/grid_tools.h> instead and remove 'parallel::'."
-
-#include <deal.II/grid/grid_tools.h>
-
-#endif // dealii_distributed_grid_tools_h
index ae0ebb475e872081e5df93df728ac8817a4a7358..4e2d8e5c5a62595aec35e318585ea9b72ea1d36a 100644 (file)
@@ -36,15 +36,6 @@ DEAL_II_NAMESPACE_OPEN
 
 namespace PETScWrappers
 {
-  /**
-   * a compatibility typedef for older versions of PETSc.
-   *
-   * @deprecated The name of this type changed in PETSc 3.2: deal.II does not
-   * support versions of PETSc older than this so this typedef will be removed
-   * in a future release.
-   */
-  typedef PetscBool PetscBooleanType DEAL_II_DEPRECATED;
-
   /**
    * Set an option in the global PETSc database. This function just wraps
    * PetscOptionsSetValue with a version check (the signature of this function
diff --git a/include/deal.II/lac/trilinos_vector_base.h b/include/deal.II/lac/trilinos_vector_base.h
deleted file mode 100644 (file)
index ebc27c2..0000000
+++ /dev/null
@@ -1,39 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2008 - 2017 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 at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-#ifndef dealii_trilinos_vector_base_h
-#define dealii_trilinos_vector_base_h
-
-#warning This file is deprecated. Use <deal.II/lac/trilinos_vector.h> instead.
-
-#include <deal.II/base/config.h>
-#include <deal.II/lac/trilinos_vector.h>
-
-DEAL_II_NAMESPACE_OPEN
-
-#ifdef DEAL_II_WITH_TRILINOS
-namespace TrilinosWrappers
-{
-  // All functionality from the former base class VectorBase was moved to
-  // MPI::Vector as this ended up to be the only derived class.
-  // Hence, using the class VectorBase is deprecated and we only provide
-  // an alias for backward compatibility.
-  typedef MPI::Vector VectorBase DEAL_II_DEPRECATED;
-}
-#endif
-
-DEAL_II_NAMESPACE_CLOSE
-
-#endif // dealii_trilinos_vector_base_h
diff --git a/include/deal.II/multigrid/mg_dof_accessor.h b/include/deal.II/multigrid/mg_dof_accessor.h
deleted file mode 100644 (file)
index 7d3f0aa..0000000
+++ /dev/null
@@ -1,22 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 1998 - 2017 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 at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-#ifndef dealii_mg_dof_accessor_h
-#define dealii_mg_dof_accessor_h
-
-#warning This file is deprecated. Use <deal.II/dofs/dof_accessor.h> instead.
-#include <deal.II/dofs/dof_accessor.h>
-
-#endif
index 6b11375a0af9ea95a2f802a7768018f6638329d4..e78175a026fbf77648a673cf6533a6dc71288bc9 100644 (file)
@@ -29,7 +29,6 @@
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/grid/manifold_lib.h>
-#include <deal.II/distributed/grid_tools.h>
 #include <deal.II/distributed/grid_refinement.h>
 
 // predicate: test if the cell is locally owned

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.