From: Wolfgang Bangerth Date: Fri, 5 May 2017 17:09:12 +0000 (-0600) Subject: Remove deprecated function Manifold::get_new_point(Quadrature). X-Git-Tag: v9.0.0-rc1~1617^2~1 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=dedf34844575b6ef63f4630ec601460bb626eaf5;p=dealii.git Remove deprecated function Manifold::get_new_point(Quadrature). --- diff --git a/include/deal.II/grid/manifold.h b/include/deal.II/grid/manifold.h index a99688ee16..c7712ab248 100644 --- a/include/deal.II/grid/manifold.h +++ b/include/deal.II/grid/manifold.h @@ -355,27 +355,6 @@ public: const Point &p2, const double w) const; - /** - * Return the point which shall become the new vertex surrounded by the - * given points which make up the quadrature. We use a quadrature object, - * which should be filled with the surrounding points together with - * appropriate weights. - * - * In its default implementation it uses a pair-wise reduction of - * the points in the quadrature formula by calling the function - * get_intermediate_point() on the first two points, then on the - * resulting point and the next, until all points in the quadrature - * have been taken into account. User classes can get away by simply - * implementing the get_intermediate_point() function. Notice that - * by default the get_intermediate_point() function calls the - * project_to_manifold() function with the convex combination of its - * arguments. For simple situations you may get away by implementing - * only the project_to_manifold() function. - */ - virtual - Point - get_new_point (const Quadrature &quad) const DEAL_II_DEPRECATED; - /** * Return the point which shall become the new vertex surrounded by the * given points @p surrounding_points. @p weights contains appropriate @@ -702,31 +681,6 @@ public: FlatManifold (const Tensor<1,spacedim> &periodicity = Tensor<1,spacedim>(), const double tolerance=1e-10); - /** - * Let the new point be the average sum of surrounding vertices. - * - * This particular implementation constructs the weighted average of the - * surrounding points, and then calls internally the function - * project_to_manifold(). The reason why we do it this way, is to allow lazy - * programmers to implement only the project_to_manifold() function for their - * own Manifold classes which are small (or trivial) perturbations of a flat - * manifold. This is the case whenever the coarse mesh is a decent - * approximation of the manifold geometry. In this case, the middle point of - * a cell is close to true middle point of the manifold, and a projection - * may suffice. - * - * For most simple geometries, it is possible to get reasonable results by - * deriving your own Manifold class from FlatManifold, and write a new - * interface only for the project_to_manifold function. You will have good - * approximations also with large deformations, as long as in the coarsest - * mesh size you are trying to refine, the middle point is not too far from - * the manifold mid point, i.e., as long as the coarse mesh size is small - * enough. - */ - virtual - Point - get_new_point(const Quadrature &quad) const DEAL_II_DEPRECATED; - /** * Let the new point be the average sum of surrounding vertices. * @@ -962,15 +916,6 @@ public: */ virtual ~ChartManifold (); - - /** - * Refer to the general documentation of this class and the documentation of - * the base class for more information. - */ - virtual - Point - get_new_point(const Quadrature &quad) const DEAL_II_DEPRECATED; - /** * Refer to the general documentation of this class and the documentation of * the base class for more information. diff --git a/include/deal.II/grid/manifold_lib.h b/include/deal.II/grid/manifold_lib.h index cde73c68d7..cc7d5e757c 100644 --- a/include/deal.II/grid/manifold_lib.h +++ b/include/deal.II/grid/manifold_lib.h @@ -227,16 +227,6 @@ public: get_tangent_vector (const Point &x1, const Point &x2) const; - /** - * Return a point on the spherical manifold which is intermediate - * with respect to the surrounding points. - * - * @deprecated Use the other function that takes points and weights separately instead. - */ - virtual - Point - get_new_point(const dealii::Quadrature &quadrature) const DEAL_II_DEPRECATED; - /** * Return a point on the spherical manifold which is intermediate * with respect to the surrounding points. @@ -292,13 +282,6 @@ public: const Point &point_on_axis, const double tolerance = 1e-10); - /** - * Compute new points on the CylindricalManifold. See the documentation of - * the base class for a detailed description of what this function does. - */ - virtual Point - get_new_point(const Quadrature &quad) const DEAL_II_DEPRECATED; - /** * Compute new points on the CylindricalManifold. See the documentation of * the base class for a detailed description of what this function does. diff --git a/source/grid/manifold.cc b/source/grid/manifold.cc index b080fb8aa8..1de1e07e8c 100644 --- a/source/grid/manifold.cc +++ b/source/grid/manifold.cc @@ -80,16 +80,6 @@ get_intermediate_point (const Point &p1, -template -Point -Manifold:: -get_new_point (const Quadrature &quad) const -{ - return get_new_point(quad.get_points(),quad.get_weights()); -} - - - template Point Manifold:: @@ -551,16 +541,6 @@ FlatManifold::FlatManifold (const Tensor<1,spacedim> &periodicity, -template -Point -FlatManifold:: -get_new_point (const Quadrature &quad) const -{ - return get_new_point(quad.get_points(),quad.get_weights()); -} - - - template Point FlatManifold:: @@ -745,16 +725,6 @@ ChartManifold::ChartManifold (const Tensor<1,chartdim> &p -template -Point -ChartManifold:: -get_new_point (const Quadrature &quad) const -{ - return get_new_point(quad.get_points(),quad.get_weights()); -} - - - template Point ChartManifold:: diff --git a/source/grid/manifold_lib.cc b/source/grid/manifold_lib.cc index b95593149a..46c46eb371 100644 --- a/source/grid/manifold_lib.cc +++ b/source/grid/manifold_lib.cc @@ -269,13 +269,7 @@ get_tangent_vector (const Point &p1, return (r1-r2)*e1 + r1*gamma*tg; } -template -Point -SphericalManifold:: -get_new_point (const Quadrature &quad) const -{ - return get_new_point(quad.get_points(),quad.get_weights()); -} + template Point @@ -329,16 +323,6 @@ CylindricalManifold::CylindricalManifold(const Point &di -template -Point -CylindricalManifold:: -get_new_point (const Quadrature &quad) const -{ - return get_new_point(quad.get_points(),quad.get_weights()); -} - - - template Point CylindricalManifold:: @@ -378,7 +362,7 @@ get_new_point (const std::vector > &surrounding_points, // ============================================================ -// FunctionChartManifold +// FunctionManifold // ============================================================ template FunctionManifold::FunctionManifold @@ -396,6 +380,8 @@ FunctionManifold::FunctionManifold AssertDimension(pull_back_function.n_components, chartdim); } + + template FunctionManifold::FunctionManifold (const std::string push_forward_expression, @@ -419,6 +405,8 @@ FunctionManifold::FunctionManifold pull_back_function = pb; } + + template FunctionManifold::~FunctionManifold() { @@ -434,6 +422,8 @@ FunctionManifold::~FunctionManifold() } } + + template Point FunctionManifold::push_forward(const Point &chart_point) const @@ -458,6 +448,7 @@ FunctionManifold::push_forward(const Point &cha } + template DerivativeForm<1,chartdim, spacedim> FunctionManifold::push_forward_gradient(const Point &chart_point) const @@ -472,6 +463,7 @@ FunctionManifold::push_forward_gradient(const Point Point FunctionManifold::pull_back(const Point &space_point) const @@ -499,6 +491,8 @@ TorusManifold::pull_back(const Point<3> &p) const return Point<3>(phi, theta, w); } + + template Point<3> TorusManifold::push_forward(const Point<3> &chart_point) const @@ -514,6 +508,7 @@ TorusManifold::push_forward(const Point<3> &chart_point) const } + template TorusManifold::TorusManifold (const double R, const double r) : ChartManifold (Point<3>(2*numbers::PI, 2*numbers::PI, 0.0)), @@ -525,6 +520,8 @@ TorusManifold::TorusManifold (const double R, const double r) Assert (r>0.0, ExcMessage("inner radius must be positive.")); } + + template DerivativeForm<1,3,3> TorusManifold::push_forward_gradient(const Point<3> &chart_point) const