* \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
* @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:
/**
* (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 ();
/**
* @author Luca Heltai, 2014
*/
template <int dim, int spacedim>
-class SphericalManifold : public ManifoldChart<dim, spacedim, spacedim>
+class SphericalManifold : public ChartManifold<dim, spacedim, spacedim>
{
public:
/**
/**
- * 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.
*
* @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
* 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
}
-/* -------------------------- 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();
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
}
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));
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;
// ============================================================
-// FunctionManifoldChart
+// FunctionChartManifold
// ============================================================
template <int dim, int spacedim, int chartdim>
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),
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)
-//---------------------------- function_manifold_chart ---------------------------
+//---------------------------- function_manifold ---------------------------
// Copyright (C) 2011, 2013 by the mathLab team.
//
// This file is subject to LGPL and may not be distributed
// 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.