From 8e0f6d33532f5aa15f8a39e6c36660fabe74100c Mon Sep 17 00:00:00 2001 From: Luca Heltai Date: Thu, 7 Aug 2014 16:47:48 +0200 Subject: [PATCH] Refactored ManifoldChart to ChartManifold. --- include/deal.II/grid/manifold.h | 8 ++++---- include/deal.II/grid/manifold_lib.h | 10 +++++----- source/grid/manifold.cc | 8 ++++---- source/grid/manifold.inst.in | 6 +++--- source/grid/manifold_lib.cc | 10 +++++----- tests/manifold/function_manifold_01.cc | 4 ++-- 6 files changed, 23 insertions(+), 23 deletions(-) diff --git a/include/deal.II/grid/manifold.h b/include/deal.II/grid/manifold.h index ad79cd4f2e..6b1b8e3875 100644 --- a/include/deal.II/grid/manifold.h +++ b/include/deal.II/grid/manifold.h @@ -367,7 +367,7 @@ private: * \f] * (the pull_back() function). * - * The get_new_point() function of the ManifoldChart class is + * The get_new_point() function of the ChartManifold class is * implemented by calling the pull_back() method for all * #surrounding_points, computing their weighted average in the * chartdim Euclidean space, and calling the push_forward() method @@ -386,7 +386,7 @@ private: * @author Luca Heltai, 2013 */ template -class ManifoldChart: public Manifold +class ChartManifold: public Manifold { public: /** @@ -405,13 +405,13 @@ public: * (eps) is not pi, but 2*pi (or zero), since, on the manifold, * these two points are at distance 2*eps and not (2*pi-eps) */ - ManifoldChart(const Point periodicity=Point()); + ChartManifold(const Point periodicity=Point()); /** * Destructor. Does nothing here, but needs to be declared to make * it virtual. */ - virtual ~ManifoldChart (); + virtual ~ChartManifold (); /** diff --git a/include/deal.II/grid/manifold_lib.h b/include/deal.II/grid/manifold_lib.h index 562efb9838..bed7dee930 100644 --- a/include/deal.II/grid/manifold_lib.h +++ b/include/deal.II/grid/manifold_lib.h @@ -55,7 +55,7 @@ DEAL_II_NAMESPACE_OPEN * @author Luca Heltai, 2014 */ template -class SphericalManifold : public ManifoldChart +class SphericalManifold : public ChartManifold { public: /** @@ -184,7 +184,7 @@ private: /** - * Manifold description derived from ManifoldChart, based on explicit + * Manifold description derived from ChartManifold, based on explicit * Function and Function objects describing the * push_forward() and pull_back() functions. * @@ -201,13 +201,13 @@ private: * @author Luca Heltai, 2014 */ template -class FunctionManifold : public ManifoldChart +class FunctionManifold : public ChartManifold { public: /** * Explicit functions constructor. Takes a push_forward function of * spacedim components, and a pull_back function of chartdim - * components. See the documentation of the base class ManifoldChart + * components. See the documentation of the base class ChartManifold * for the meaning of the optional #periodicity argument. * * The tolerance argument is used in debug mode to actually check @@ -222,7 +222,7 @@ public: * Expressions constructor. Takes the expressions of the * push_forward function of spacedim components, and of the * pull_back function of chartdim components. See the documentation - * of the base class ManifoldChart for the meaning of the optional + * of the base class ChartManifold for the meaning of the optional * #periodicity argument. * * The strings should be the readable by the default constructor of diff --git a/source/grid/manifold.cc b/source/grid/manifold.cc index 0b728dacb3..ccd7e47c64 100644 --- a/source/grid/manifold.cc +++ b/source/grid/manifold.cc @@ -325,21 +325,21 @@ FlatManifold::project_to_manifold (const std::vector -ManifoldChart::~ManifoldChart () +ChartManifold::~ChartManifold () {} template -ManifoldChart::ManifoldChart (const Point periodicity): +ChartManifold::ChartManifold (const Point periodicity): sub_manifold(periodicity) {} template Point -ManifoldChart:: +ChartManifold:: get_new_point (const Quadrature &quad) const { const std::vector > &surrounding_points = quad.get_points(); diff --git a/source/grid/manifold.inst.in b/source/grid/manifold.inst.in index 164e479df2..d5b8789f71 100644 --- a/source/grid/manifold.inst.in +++ b/source/grid/manifold.inst.in @@ -22,9 +22,9 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS template class Manifold; template class FlatManifold; - template class ManifoldChart; - template class ManifoldChart; - template class ManifoldChart; + template class ChartManifold; + template class ChartManifold; + template class ChartManifold; #endif } diff --git a/source/grid/manifold_lib.cc b/source/grid/manifold_lib.cc index 209b10b1dd..c2e0a42279 100644 --- a/source/grid/manifold_lib.cc +++ b/source/grid/manifold_lib.cc @@ -26,7 +26,7 @@ DEAL_II_NAMESPACE_OPEN template SphericalManifold::SphericalManifold(const Point center): - ManifoldChart(SphericalManifold::get_periodicity()), + ChartManifold(SphericalManifold::get_periodicity()), center(center) { Assert(spacedim != 1, ExcImpossibleInDim(1)); @@ -49,7 +49,7 @@ Point SphericalManifold::get_new_point(const Quadrature &quad) const { if (spacedim == 2) - return ManifoldChart::get_new_point(quad); + return ChartManifold::get_new_point(quad); else { double rho_average = 0; @@ -205,7 +205,7 @@ get_new_point (const Quadrature &quad) const // ============================================================ -// FunctionManifoldChart +// FunctionChartManifold // ============================================================ template FunctionManifold::FunctionManifold @@ -213,7 +213,7 @@ FunctionManifold::FunctionManifold const Function &pull_back_function, const Point periodicity, const double tolerance): - ManifoldChart(periodicity), + ChartManifold(periodicity), push_forward_function(&push_forward_function), pull_back_function(&pull_back_function), tolerance(tolerance), @@ -232,7 +232,7 @@ FunctionManifold::FunctionManifold const std::string chart_vars, const std::string space_vars, const double tolerance) : - ManifoldChart(periodicity), + ChartManifold(periodicity), const_map(const_map), tolerance(tolerance), owns_pointers(true) diff --git a/tests/manifold/function_manifold_01.cc b/tests/manifold/function_manifold_01.cc index e63969370c..6ae95e893d 100644 --- a/tests/manifold/function_manifold_01.cc +++ b/tests/manifold/function_manifold_01.cc @@ -1,4 +1,4 @@ -//---------------------------- function_manifold_chart --------------------------- +//---------------------------- function_manifold --------------------------- // Copyright (C) 2011, 2013 by the mathLab team. // // This file is subject to LGPL and may not be distributed @@ -6,7 +6,7 @@ // to the file deal.II/doc/license.html for the text and // further information on this license. // -//---------------------------- function_manifold_chart --------------------------- +//---------------------------- function_manifold --------------------------- // Test the identity Manifold. -- 2.39.5