]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix indentation
authorPraveen C <cpraveen@gmail.com>
Sun, 19 Nov 2017 05:01:00 +0000 (10:31 +0530)
committerPraveen C <cpraveen@gmail.com>
Sun, 19 Nov 2017 05:01:00 +0000 (10:31 +0530)
include/deal.II/fe/fe_face.h
include/deal.II/fe/fe_trace.h
source/fe/fe_face.cc
source/fe/fe_trace.cc
tests/fe/fe_faceq_interpolate.cc
tests/fe/fe_traceq_interpolate.cc

index b795fc1fcb1c9472bec6af7cc80ae48b69aefb1c..a8ef8aebfff28cc5f31a9bd26278a88ad2a4da68 100644 (file)
@@ -70,17 +70,17 @@ public:
    */
   virtual std::string get_name () const;
 
-   /**
-    * Implementation of the corresponding function in the FiniteElement
-    * class.  Since the current element is interpolatory, the nodal
-    * values are exactly the support point values. Furthermore, since
-    * the current element is scalar, the support point values need to
-    * be vectors of length 1.
-    */
-   virtual
-   void
-   convert_generalized_support_point_values_to_dof_values (const std::vector<Vector<double> > &support_point_values,
-                                                           std::vector<double>                &nodal_values) const;
+  /**
+   * Implementation of the corresponding function in the FiniteElement
+   * class.  Since the current element is interpolatory, the nodal
+   * values are exactly the support point values. Furthermore, since
+   * the current element is scalar, the support point values need to
+   * be vectors of length 1.
+   */
+  virtual
+  void
+  convert_generalized_support_point_values_to_dof_values (const std::vector<Vector<double> > &support_point_values,
+                                                          std::vector<double>                &nodal_values) const;
 
   /**
    * Return the matrix interpolating from a face of of one element to the face
index fbadc0ffa4c710d1db9ec1acfecece2461b194eb..4536f1290f41d2a5d5b4b2beb71ef195646e1037 100644 (file)
@@ -62,13 +62,13 @@ public:
   std::unique_ptr<FiniteElement<dim,spacedim> >
   clone() const;
 
-   /**
-    * Implementation of the corresponding function in the FiniteElement
-    * class.  Since the current element is interpolatory, the nodal
-    * values are exactly the support point values. Furthermore, since
-    * the current element is scalar, the support point values need to
-    * be vectors of length 1.
-    */
+  /**
+   * Implementation of the corresponding function in the FiniteElement
+   * class.  Since the current element is interpolatory, the nodal
+   * values are exactly the support point values. Furthermore, since
+   * the current element is scalar, the support point values need to
+   * be vectors of length 1.
+   */
   virtual
   void
   convert_generalized_support_point_values_to_dof_values (const std::vector<Vector<double> > &support_point_values,
index 3c1cb96a296fee6d410e47bfa316bad70c9fdf32..bd01973af1092396341dc1ab481b77b27d497c26 100644 (file)
@@ -50,8 +50,8 @@ FE_FaceQ<dim,spacedim>::FE_FaceQ (const unsigned int degree)
   :
   FE_PolyFace<TensorProductPolynomials<dim-1>, dim, spacedim>
   (TensorProductPolynomials<dim-1>(Polynomials::generate_complete_Lagrange_basis(internal::FE_FaceQ::get_QGaussLobatto_points(degree))),
-   FiniteElementData<dim>(get_dpo_vector(degree), 1, degree, FiniteElementData<dim>::L2),
-   std::vector<bool>(1,true))
+  FiniteElementData<dim>(get_dpo_vector(degree), 1, degree, FiniteElementData<dim>::L2),
+  std::vector<bool>(1,true))
 {
   // initialize unit face support points
   const unsigned int codim = dim-1;
@@ -321,19 +321,19 @@ FE_FaceQ<dim,spacedim>::
 convert_generalized_support_point_values_to_dof_values (const std::vector<Vector<double> > &support_point_values,
                                                         std::vector<double>                &nodal_values) const
 {
-   AssertDimension (support_point_values.size(),
-                    this->get_unit_support_points().size());
-   AssertDimension (support_point_values.size(),
-                    nodal_values.size());
-   AssertDimension (this->dofs_per_cell,
-                    nodal_values.size());
+  AssertDimension (support_point_values.size(),
+                   this->get_unit_support_points().size());
+  AssertDimension (support_point_values.size(),
+                   nodal_values.size());
+  AssertDimension (this->dofs_per_cell,
+                   nodal_values.size());
 
-   for (unsigned int i=0; i<this->dofs_per_cell; ++i)
-   {
+  for (unsigned int i=0; i<this->dofs_per_cell; ++i)
+    {
       AssertDimension (support_point_values[i].size(), 1);
 
       nodal_values[i] = support_point_values[i](0);
-   }
+    }
 }
 
 // ----------------------------- FE_FaceQ<1,spacedim> ------------------------
@@ -342,8 +342,8 @@ template <int spacedim>
 FE_FaceQ<1,spacedim>::FE_FaceQ (const unsigned int degree)
   :
   FiniteElement<1,spacedim> (FiniteElementData<1>(get_dpo_vector(degree), 1, degree, FiniteElementData<1>::L2),
-                             std::vector<bool>(1,true),
-                             std::vector<ComponentMask> (1, ComponentMask(1,true)))
+                            std::vector<bool>(1,true),
+                            std::vector<ComponentMask> (1, ComponentMask(1,true)))
 {
   this->unit_face_support_points.resize(1);
 
@@ -547,8 +547,8 @@ FE_FaceP<dim,spacedim>::FE_FaceP (const unsigned int degree)
   :
   FE_PolyFace<PolynomialSpace<dim-1>, dim, spacedim>
   (PolynomialSpace<dim-1>(Polynomials::Legendre::generate_complete_basis(degree)),
-   FiniteElementData<dim>(get_dpo_vector(degree), 1, degree, FiniteElementData<dim>::L2),
-   std::vector<bool>(1,true))
+  FiniteElementData<dim>(get_dpo_vector(degree), 1, degree, FiniteElementData<dim>::L2),
+  std::vector<bool>(1,true))
 {}
 
 
index 4bc1bd659404eddde42678b1f4354389e22c15ac..73f4c3c3019c04436dada40702fcf5ed7b39610f 100644 (file)
@@ -36,9 +36,9 @@ template <int dim, int spacedim>
 FE_TraceQ<dim,spacedim>::FE_TraceQ (const unsigned int degree)
   :
   FE_PolyFace<TensorProductPolynomials<dim-1>, dim, spacedim> (
-    TensorProductPolynomials<dim-1>(Polynomials::generate_complete_Lagrange_basis(QGaussLobatto<1>(degree+1).get_points())),
-    FiniteElementData<dim>(get_dpo_vector(degree), 1, degree, FiniteElementData<dim>::L2),
-    std::vector<bool>(1,true)),
+   TensorProductPolynomials<dim-1>(Polynomials::generate_complete_Lagrange_basis(QGaussLobatto<1>(degree+1).get_points())),
+   FiniteElementData<dim>(get_dpo_vector(degree), 1, degree, FiniteElementData<dim>::L2),
+   std::vector<bool>(1,true)),
   fe_q (degree)
 {
   Assert (degree > 0,
@@ -128,19 +128,19 @@ FE_TraceQ<dim,spacedim>::
 convert_generalized_support_point_values_to_dof_values (const std::vector<Vector<double> > &support_point_values,
                                                         std::vector<double>                &nodal_values) const
 {
-   AssertDimension (support_point_values.size(),
-                    this->get_unit_support_points().size());
-   AssertDimension (support_point_values.size(),
-                    nodal_values.size());
-   AssertDimension (this->dofs_per_cell,
-                    nodal_values.size());
-
-   for (unsigned int i=0; i<this->dofs_per_cell; ++i)
-   {
+  AssertDimension (support_point_values.size(),
+                   this->get_unit_support_points().size());
+  AssertDimension (support_point_values.size(),
+                   nodal_values.size());
+  AssertDimension (this->dofs_per_cell,
+                   nodal_values.size());
+
+  for (unsigned int i=0; i<this->dofs_per_cell; ++i)
+    {
       AssertDimension (support_point_values[i].size(), 1);
 
       nodal_values[i] = support_point_values[i](0);
-   }
+    }
 }
 
 
index c8574b71663885bf9cd3915a825d3899371de45b..bcbbed05f52db1001edd277108d39e715b942429 100644 (file)
@@ -29,27 +29,27 @@ using namespace dealii;
 template <int dim>
 void test()
 {
-   Triangulation<dim>    triangulation;
-   FE_FaceQ<dim>         fe(2);
-   DoFHandler<dim>       dof_handler(triangulation);
+  Triangulation<dim>    triangulation;
+  FE_FaceQ<dim>         fe(2);
+  DoFHandler<dim>       dof_handler(triangulation);
 
-   GridGenerator::hyper_cube (triangulation, 0, 1);
-   triangulation.refine_global(6);
+  GridGenerator::hyper_cube (triangulation, 0, 1);
+  triangulation.refine_global(6);
 
-   dof_handler.distribute_dofs (fe);
-   Vector<double> solution(dof_handler.n_dofs());
+  dof_handler.distribute_dofs (fe);
+  Vector<double> solution(dof_handler.n_dofs());
 
-   VectorTools::interpolate(dof_handler,
-                            ZeroFunction<dim>(),
-                            solution);
-   deallog << "Success, dim = " << dim << std::endl;
+  VectorTools::interpolate(dof_handler,
+                           ZeroFunction<dim>(),
+                           solution);
+  deallog << "Success, dim = " << dim << std::endl;
 }
 
 int main()
 {
-   initlog();
+  initlog();
 
-   test<2>();
-   test<3>();
-   return 0;
+  test<2>();
+  test<3>();
+  return 0;
 }
index bfca5bfaa7379f7824644e61f6b8cb30f86dd525..f40c62ba6a086b084b72e3c8f8792b623a7b308d 100644 (file)
@@ -29,27 +29,27 @@ using namespace dealii;
 template <int dim>
 void test()
 {
-   Triangulation<dim>    triangulation;
-   FE_TraceQ<dim>         fe(2);
-   DoFHandler<dim>       dof_handler(triangulation);
+  Triangulation<dim>    triangulation;
+  FE_TraceQ<dim>         fe(2);
+  DoFHandler<dim>       dof_handler(triangulation);
 
-   GridGenerator::hyper_cube (triangulation, 0, 1);
-   triangulation.refine_global(6);
+  GridGenerator::hyper_cube (triangulation, 0, 1);
+  triangulation.refine_global(6);
 
-   dof_handler.distribute_dofs (fe);
-   Vector<double> solution(dof_handler.n_dofs());
+  dof_handler.distribute_dofs (fe);
+  Vector<double> solution(dof_handler.n_dofs());
 
-   VectorTools::interpolate(dof_handler,
-                            ZeroFunction<dim>(),
-                            solution);
-   deallog << "Success, dim = " << dim << std::endl;
+  VectorTools::interpolate(dof_handler,
+                           ZeroFunction<dim>(),
+                           solution);
+  deallog << "Success, dim = " << dim << std::endl;
 }
 
 int main()
 {
-   initlog();
+  initlog();
 
-   test<2>();
-   test<3>();
-   return 0;
+  test<2>();
+  test<3>();
+  return 0;
 }

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.