From 5fa5e8741590e3d70409c73bdf5d7779a2c1b790 Mon Sep 17 00:00:00 2001 From: Daniel Arndt Date: Wed, 24 Jun 2020 15:51:31 -0400 Subject: [PATCH] Remove FunctionMap --- .../deal.II/dofs/deprecated_function_map.h | 91 ------------------- include/deal.II/dofs/dof_handler.h | 1 - include/deal.II/dofs/function_map.h | 25 ----- include/deal.II/numerics/error_estimator.h | 2 - include/deal.II/numerics/matrix_tools.h | 2 - tests/fe/fe_enriched_color_07.cc | 30 +++--- 6 files changed, 16 insertions(+), 135 deletions(-) delete mode 100644 include/deal.II/dofs/deprecated_function_map.h delete mode 100644 include/deal.II/dofs/function_map.h diff --git a/include/deal.II/dofs/deprecated_function_map.h b/include/deal.II/dofs/deprecated_function_map.h deleted file mode 100644 index e64a2ad130..0000000000 --- a/include/deal.II/dofs/deprecated_function_map.h +++ /dev/null @@ -1,91 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2018 - 2020 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_deprecated_function_map_h -#define dealii_deprecated_function_map_h - -#include - -#include - -DEAL_II_NAMESPACE_OPEN - -// Forward declaration -#ifndef DOXYGEN -template -class Function; -#endif - - -/** - * This class declares a local alias that denotes a mapping between a boundary - * indicator (see - * @ref GlossBoundaryIndicator) - * that is used to describe what - * kind of boundary condition holds on a particular piece of the boundary, and - * the function describing the actual function that provides the boundary values - * on this part of the boundary. This type is required in many functions in the - * library where, for example, we need to know about the functions - * $h_i(\mathbf x)$ used in boundary conditions - * @f{align*}{ - * \mathbf n \cdot \nabla u = h_i \qquad \qquad - * \text{on}\ \Gamma_i\subset\partial\Omega. - * @f} - * An example is the function KellyErrorEstimator::estimate() that allows us to - * provide a set of functions $h_i$ for all those boundary indicators $i$ for - * which the boundary condition is supposed to be of Neumann type. Of course, - * the same kind of principle can be applied to cases where we care about - * Dirichlet values, where one needs to provide a map from boundary indicator - * $i$ to Dirichlet function $h_i$ if the boundary conditions are given as - * @f{align*}{ - * u = h_i \qquad \qquad \text{on}\ \Gamma_i\subset\partial\Omega. - * @f} - * This is, for example, the case for the VectorTools::interpolate() functions. - * - * Tutorial programs step-6, step-7 and step-8 show examples of how to use - * function arguments of this type in situations where we actually have an empty - * map (i.e., we want to describe that no part of the boundary is a - * Neumann boundary). step-16 actually uses it in a case where one of the parts - * of the boundary uses a boundary indicator for which we want to use a function - * object. - * - * It seems odd at first to declare this alias inside a class, rather than - * declaring an alias at global scope. The reason is that C++ does not allow to - * define templated alias, where here in fact we want an alias that depends on - * the space dimension. (Defining templated alias is something that is possible - * starting with the C++11 standard, but that wasn't possible within the C++98 - * standard in place when this programming pattern was conceived.) - * - * @ingroup functions - */ -template -struct DEAL_II_DEPRECATED FunctionMap -{ - /** - * Declare the type as discussed above. Since we can't name it FunctionMap - * (as that would ambiguate a possible constructor of this class), name it - * in the fashion of the standard container local alias. - * - * @deprecated Directly use the type - * std::map *> - * in your code instead of this alias. - */ - using type DEAL_II_DEPRECATED = - std::map *>; -}; - -DEAL_II_NAMESPACE_CLOSE - -#endif diff --git a/include/deal.II/dofs/dof_handler.h b/include/deal.II/dofs/dof_handler.h index fe4934b5a2..ace14db908 100644 --- a/include/deal.II/dofs/dof_handler.h +++ b/include/deal.II/dofs/dof_handler.h @@ -29,7 +29,6 @@ #include #include -#include #include #include #include diff --git a/include/deal.II/dofs/function_map.h b/include/deal.II/dofs/function_map.h deleted file mode 100644 index b263aafad7..0000000000 --- a/include/deal.II/dofs/function_map.h +++ /dev/null @@ -1,25 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2001 - 2018 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_function_map_h -#define dealii_function_map_h - -#include - -#include - -DEAL_II_WARNING("This file is deprecated.") - -#endif diff --git a/include/deal.II/numerics/error_estimator.h b/include/deal.II/numerics/error_estimator.h index a5a88a6585..220b3fc692 100644 --- a/include/deal.II/numerics/error_estimator.h +++ b/include/deal.II/numerics/error_estimator.h @@ -22,8 +22,6 @@ #include #include -#include - #include #include diff --git a/include/deal.II/numerics/matrix_tools.h b/include/deal.II/numerics/matrix_tools.h index cdfcc5e610..9cc5032051 100644 --- a/include/deal.II/numerics/matrix_tools.h +++ b/include/deal.II/numerics/matrix_tools.h @@ -22,8 +22,6 @@ #include #include -#include - #include #include diff --git a/tests/fe/fe_enriched_color_07.cc b/tests/fe/fe_enriched_color_07.cc index 16846b9ffe..438a682bc3 100644 --- a/tests/fe/fe_enriched_color_07.cc +++ b/tests/fe/fe_enriched_color_07.cc @@ -813,11 +813,12 @@ void EstimateEnrichmentFunction::refine_grid() { Vector estimated_error_per_cell(triangulation.n_active_cells()); - KellyErrorEstimator<1>::estimate(dof_handler, - QGauss<1 - 1>(3), - typename FunctionMap<1>::type(), - solution, - estimated_error_per_cell); + KellyErrorEstimator<1>::estimate( + dof_handler, + QGauss<1 - 1>(3), + std::map *>{}, + solution, + estimated_error_per_cell); GridRefinement::refine_and_coarsen_fixed_number(triangulation, estimated_error_per_cell, 0.2, @@ -1599,15 +1600,16 @@ LaplaceProblem::refine_grid() for (unsigned int i = 0; i < q_collection.size(); ++i) q_collection_face.push_back(QGauss(1)); - KellyErrorEstimator::estimate(dof_handler, - q_collection_face, - typename FunctionMap::type(), - localized_solution, - local_error_per_cell, - ComponentMask(), - nullptr, - n_mpi_processes, - this_mpi_process); + KellyErrorEstimator::estimate( + dof_handler, + q_collection_face, + std::map *>{}, + localized_solution, + local_error_per_cell, + ComponentMask(), + nullptr, + n_mpi_processes, + this_mpi_process); const unsigned int n_local_cells = GridTools::count_cells_with_subdomain_association(triangulation, this_mpi_process); -- 2.39.5