From: Praveen C Date: Sun, 19 Nov 2017 05:01:00 +0000 (+0530) Subject: Fix indentation X-Git-Tag: v9.0.0-rc1~752^2~2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=5330e568bed291b112975e3d69001ce51244ae88;p=dealii.git Fix indentation --- diff --git a/include/deal.II/fe/fe_face.h b/include/deal.II/fe/fe_face.h index b795fc1fcb..a8ef8aebff 100644 --- a/include/deal.II/fe/fe_face.h +++ b/include/deal.II/fe/fe_face.h @@ -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 > &support_point_values, - std::vector &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 > &support_point_values, + std::vector &nodal_values) const; /** * Return the matrix interpolating from a face of of one element to the face diff --git a/include/deal.II/fe/fe_trace.h b/include/deal.II/fe/fe_trace.h index fbadc0ffa4..4536f1290f 100644 --- a/include/deal.II/fe/fe_trace.h +++ b/include/deal.II/fe/fe_trace.h @@ -62,13 +62,13 @@ public: std::unique_ptr > 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 > &support_point_values, diff --git a/source/fe/fe_face.cc b/source/fe/fe_face.cc index 3c1cb96a29..bd01973af1 100644 --- a/source/fe/fe_face.cc +++ b/source/fe/fe_face.cc @@ -50,8 +50,8 @@ FE_FaceQ::FE_FaceQ (const unsigned int degree) : FE_PolyFace, dim, spacedim> (TensorProductPolynomials(Polynomials::generate_complete_Lagrange_basis(internal::FE_FaceQ::get_QGaussLobatto_points(degree))), - FiniteElementData(get_dpo_vector(degree), 1, degree, FiniteElementData::L2), - std::vector(1,true)) + FiniteElementData(get_dpo_vector(degree), 1, degree, FiniteElementData::L2), + std::vector(1,true)) { // initialize unit face support points const unsigned int codim = dim-1; @@ -321,19 +321,19 @@ FE_FaceQ:: convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, std::vector &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; idofs_per_cell; ++i) - { + for (unsigned int i=0; idofs_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 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(1,true), - std::vector (1, ComponentMask(1,true))) + std::vector(1,true), + std::vector (1, ComponentMask(1,true))) { this->unit_face_support_points.resize(1); @@ -547,8 +547,8 @@ FE_FaceP::FE_FaceP (const unsigned int degree) : FE_PolyFace, dim, spacedim> (PolynomialSpace(Polynomials::Legendre::generate_complete_basis(degree)), - FiniteElementData(get_dpo_vector(degree), 1, degree, FiniteElementData::L2), - std::vector(1,true)) + FiniteElementData(get_dpo_vector(degree), 1, degree, FiniteElementData::L2), + std::vector(1,true)) {} diff --git a/source/fe/fe_trace.cc b/source/fe/fe_trace.cc index 4bc1bd6594..73f4c3c301 100644 --- a/source/fe/fe_trace.cc +++ b/source/fe/fe_trace.cc @@ -36,9 +36,9 @@ template FE_TraceQ::FE_TraceQ (const unsigned int degree) : FE_PolyFace, dim, spacedim> ( - TensorProductPolynomials(Polynomials::generate_complete_Lagrange_basis(QGaussLobatto<1>(degree+1).get_points())), - FiniteElementData(get_dpo_vector(degree), 1, degree, FiniteElementData::L2), - std::vector(1,true)), + TensorProductPolynomials(Polynomials::generate_complete_Lagrange_basis(QGaussLobatto<1>(degree+1).get_points())), + FiniteElementData(get_dpo_vector(degree), 1, degree, FiniteElementData::L2), + std::vector(1,true)), fe_q (degree) { Assert (degree > 0, @@ -128,19 +128,19 @@ FE_TraceQ:: convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, std::vector &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; idofs_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; idofs_per_cell; ++i) + { AssertDimension (support_point_values[i].size(), 1); nodal_values[i] = support_point_values[i](0); - } + } } diff --git a/tests/fe/fe_faceq_interpolate.cc b/tests/fe/fe_faceq_interpolate.cc index c8574b7166..bcbbed05f5 100644 --- a/tests/fe/fe_faceq_interpolate.cc +++ b/tests/fe/fe_faceq_interpolate.cc @@ -29,27 +29,27 @@ using namespace dealii; template void test() { - Triangulation triangulation; - FE_FaceQ fe(2); - DoFHandler dof_handler(triangulation); + Triangulation triangulation; + FE_FaceQ fe(2); + DoFHandler 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 solution(dof_handler.n_dofs()); + dof_handler.distribute_dofs (fe); + Vector solution(dof_handler.n_dofs()); - VectorTools::interpolate(dof_handler, - ZeroFunction(), - solution); - deallog << "Success, dim = " << dim << std::endl; + VectorTools::interpolate(dof_handler, + ZeroFunction(), + solution); + deallog << "Success, dim = " << dim << std::endl; } int main() { - initlog(); + initlog(); - test<2>(); - test<3>(); - return 0; + test<2>(); + test<3>(); + return 0; } diff --git a/tests/fe/fe_traceq_interpolate.cc b/tests/fe/fe_traceq_interpolate.cc index bfca5bfaa7..f40c62ba6a 100644 --- a/tests/fe/fe_traceq_interpolate.cc +++ b/tests/fe/fe_traceq_interpolate.cc @@ -29,27 +29,27 @@ using namespace dealii; template void test() { - Triangulation triangulation; - FE_TraceQ fe(2); - DoFHandler dof_handler(triangulation); + Triangulation triangulation; + FE_TraceQ fe(2); + DoFHandler 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 solution(dof_handler.n_dofs()); + dof_handler.distribute_dofs (fe); + Vector solution(dof_handler.n_dofs()); - VectorTools::interpolate(dof_handler, - ZeroFunction(), - solution); - deallog << "Success, dim = " << dim << std::endl; + VectorTools::interpolate(dof_handler, + ZeroFunction(), + solution); + deallog << "Success, dim = " << dim << std::endl; } int main() { - initlog(); + initlog(); - test<2>(); - test<3>(); - return 0; + test<2>(); + test<3>(); + return 0; }