]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Refactored ManifoldChart to ChartManifold.
authorLuca Heltai <luca.heltai@sissa.it>
Thu, 7 Aug 2014 14:47:48 +0000 (16:47 +0200)
committerLuca Heltai <luca.heltai@sissa.it>
Thu, 7 Aug 2014 14:47:48 +0000 (16:47 +0200)
include/deal.II/grid/manifold.h
include/deal.II/grid/manifold_lib.h
source/grid/manifold.cc
source/grid/manifold.inst.in
source/grid/manifold_lib.cc
tests/manifold/function_manifold_01.cc

index ad79cd4f2e2fc381e1b73f48332700e23e038adb..6b1b8e387517c9d35ec6e2f8b4fde8490a12a9a5 100644 (file)
@@ -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 <int dim, int spacedim=dim, int chartdim=dim>
-class ManifoldChart: public Manifold<dim,spacedim>
+class ChartManifold: public Manifold<dim,spacedim>
 {
 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<chartdim> periodicity=Point<chartdim>());
+  ChartManifold(const Point<chartdim> periodicity=Point<chartdim>());
 
   /**
    * Destructor. Does nothing here, but needs to be declared to make
    * it virtual.
    */
-  virtual ~ManifoldChart ();
+  virtual ~ChartManifold ();
 
 
   /**
index 562efb98382ceeef81250ca53648f2a4792c9a0f..bed7dee93051c504fc1c111eece068e652e8628b 100644 (file)
@@ -55,7 +55,7 @@ DEAL_II_NAMESPACE_OPEN
  * @author Luca Heltai, 2014
  */
 template <int dim, int spacedim>
-class SphericalManifold : public ManifoldChart<dim, spacedim, spacedim>
+class SphericalManifold : public ChartManifold<dim, spacedim, spacedim>
 {
 public:
   /**
@@ -184,7 +184,7 @@ private:
 
 
 /**
- * Manifold description derived from ManifoldChart, based on explicit
+ * Manifold description derived from ChartManifold, based on explicit
  * Function<spacedim> and Function<chartdim> objects describing the
  * push_forward() and pull_back() functions. 
  *
@@ -201,13 +201,13 @@ private:
  * @author Luca Heltai, 2014
  */
 template <int dim, int spacedim=dim, int chartdim=dim>
-class FunctionManifold : public ManifoldChart<dim, spacedim, chartdim> 
+class FunctionManifold : public ChartManifold<dim, spacedim, chartdim> 
 {
 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
index 0b728dacb332d432bfe211f1dd70c8e59de1b4ba..ccd7e47c647bcb978f5d2f5fd3a0ed7ffe826137 100644 (file)
@@ -325,21 +325,21 @@ FlatManifold<dim, spacedim>::project_to_manifold (const std::vector<Point<spaced
 }
 
 
-/* -------------------------- ManifoldChart --------------------- */
+/* -------------------------- ChartManifold --------------------- */
 
 template <int dim, int spacedim, int chartdim>
-ManifoldChart<dim,spacedim,chartdim>::~ManifoldChart ()
+ChartManifold<dim,spacedim,chartdim>::~ChartManifold ()
 {}
 
 template <int dim, int spacedim, int chartdim>
-ManifoldChart<dim,spacedim,chartdim>::ManifoldChart (const Point<chartdim> periodicity):
+ChartManifold<dim,spacedim,chartdim>::ChartManifold (const Point<chartdim> periodicity):
   sub_manifold(periodicity)
 {}
 
 
 template <int dim, int spacedim, int chartdim>
 Point<spacedim>
-ManifoldChart<dim,spacedim,chartdim>::
+ChartManifold<dim,spacedim,chartdim>::
 get_new_point (const Quadrature<spacedim> &quad) const
 {
   const std::vector<Point<spacedim> > &surrounding_points = quad.get_points();
index 164e479df24d29d97e9df18092b25bf44fc3b8ee..d5b8789f71d810de35ec54b69b27cf8bb0682dca 100644 (file)
@@ -22,9 +22,9 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
     template class Manifold<deal_II_dimension, deal_II_space_dimension>;
     template class FlatManifold<deal_II_dimension, deal_II_space_dimension>;
 
-    template class ManifoldChart<deal_II_dimension, deal_II_space_dimension, 1>;
-    template class ManifoldChart<deal_II_dimension, deal_II_space_dimension, 2>;
-    template class ManifoldChart<deal_II_dimension, deal_II_space_dimension, 3>;
+    template class ChartManifold<deal_II_dimension, deal_II_space_dimension, 1>;
+    template class ChartManifold<deal_II_dimension, deal_II_space_dimension, 2>;
+    template class ChartManifold<deal_II_dimension, deal_II_space_dimension, 3>;
 #endif
   }
 
index 209b10b1ddd9b7316dfcc2a187511f5c22665ba7..c2e0a42279558cd7ce610694d22f08c4a8031619 100644 (file)
@@ -26,7 +26,7 @@ DEAL_II_NAMESPACE_OPEN
 
 template <int dim, int spacedim>
 SphericalManifold<dim,spacedim>::SphericalManifold(const Point<spacedim> center):
-  ManifoldChart<dim,spacedim,spacedim>(SphericalManifold<dim,spacedim>::get_periodicity()),
+  ChartManifold<dim,spacedim,spacedim>(SphericalManifold<dim,spacedim>::get_periodicity()),
   center(center)
 {
   Assert(spacedim != 1, ExcImpossibleInDim(1));
@@ -49,7 +49,7 @@ Point<spacedim>
 SphericalManifold<dim,spacedim>::get_new_point(const Quadrature<spacedim> &quad) const
 {
   if (spacedim == 2)
-    return ManifoldChart<dim,spacedim,spacedim>::get_new_point(quad);
+    return ChartManifold<dim,spacedim,spacedim>::get_new_point(quad);
   else
     {
       double rho_average = 0;
@@ -205,7 +205,7 @@ get_new_point (const Quadrature<spacedim> &quad) const
 
 
 // ============================================================
-// FunctionManifoldChart
+// FunctionChartManifold
 // ============================================================
 template <int dim, int spacedim, int chartdim>
 FunctionManifold<dim,spacedim,chartdim>::FunctionManifold
@@ -213,7 +213,7 @@ FunctionManifold<dim,spacedim,chartdim>::FunctionManifold
  const Function<spacedim> &pull_back_function,
  const Point<chartdim> periodicity,
  const double tolerance):
-  ManifoldChart<dim,spacedim,chartdim>(periodicity),
+  ChartManifold<dim,spacedim,chartdim>(periodicity),
   push_forward_function(&push_forward_function),
   pull_back_function(&pull_back_function),
   tolerance(tolerance),
@@ -232,7 +232,7 @@ FunctionManifold<dim,spacedim,chartdim>::FunctionManifold
  const std::string chart_vars, 
  const std::string space_vars,
  const double tolerance) :
-  ManifoldChart<dim,spacedim,chartdim>(periodicity),
+  ChartManifold<dim,spacedim,chartdim>(periodicity),
   const_map(const_map),
   tolerance(tolerance),
   owns_pointers(true)
index e63969370c10306e62041b85afc13a8cf6da8b61..6ae95e893d840ba732ba158d0d98f23f798afe9d 100644 (file)
@@ -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.

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.