From: David Wells Date: Thu, 1 Sep 2016 23:21:16 +0000 (-0400) Subject: Reindent some VectorTools functions. X-Git-Tag: v8.5.0-rc1~693^2~2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=b9339f6871526fba3740695f07e6146e5f23bb8c;p=dealii.git Reindent some VectorTools functions. --- diff --git a/include/deal.II/numerics/vector_tools.h b/include/deal.II/numerics/vector_tools.h index 332a354a94..2dc321075d 100644 --- a/include/deal.II/numerics/vector_tools.h +++ b/include/deal.II/numerics/vector_tools.h @@ -815,11 +815,11 @@ namespace VectorTools const Quadrature &quadrature, const Function &function, VectorType &vec, - const bool enforce_zero_boundary = false, + const bool enforce_zero_boundary = false, const Quadrature &q_boundary = (dim > 1 ? QGauss(2) : Quadrature(0)), - const bool project_to_boundary_first = false); + const bool project_to_boundary_first = false); /** * Same as above, but for arguments of type hp::DoFHandler, @@ -832,11 +832,11 @@ namespace VectorTools const hp::QCollection &quadrature, const Function &function, VectorType &vec, - const bool enforce_zero_boundary = false, + const bool enforce_zero_boundary = false, const hp::QCollection &q_boundary = hp::QCollection(dim > 1 ? QGauss(2) : Quadrature(0)), - const bool project_to_boundary_first = false); + const bool project_to_boundary_first = false); /** * Call the project() function above, with a collection of $Q_1$ mapping @@ -846,13 +846,13 @@ namespace VectorTools void project (const hp::DoFHandler &dof, const ConstraintMatrix &constraints, const hp::QCollection &quadrature, - const Function &function, + const Function &function, VectorType &vec, - const bool enforce_zero_boundary = false, + const bool enforce_zero_boundary = false, const hp::QCollection &q_boundary = hp::QCollection(dim > 1 ? QGauss(2) : Quadrature(0)), - const bool project_to_boundary_first = false); + const bool project_to_boundary_first = false); /** * Compute Dirichlet boundary conditions. This function makes up a map of @@ -919,11 +919,11 @@ namespace VectorTools template void interpolate_boundary_values - (const hp::MappingCollection &mapping, - const hp::DoFHandler &dof, + (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, const std::map*> &function_map, - std::map &boundary_values, - const ComponentMask &component_mask = ComponentMask()); + std::map &boundary_values, + const ComponentMask &component_mask = ComponentMask()); /** * Same function as above, but taking only one pair of boundary indicator @@ -1158,45 +1158,49 @@ namespace VectorTools * component in @p dof. By default, no remapping is applied. */ template - void project_boundary_values (const Mapping &mapping, - const DoFHandler &dof, - const std::map*> &boundary_functions, - const Quadrature &q, - std::map &boundary_values, - std::vector component_mapping = std::vector()); + void project_boundary_values + (const Mapping &mapping, + const DoFHandler &dof, + const std::map*> &boundary_functions, + const Quadrature &q, + std::map &boundary_values, + std::vector component_mapping = std::vector()); /** * Call the project_boundary_values() function, see above, with * mapping=MappingQGeneric@(1). */ template - void project_boundary_values (const DoFHandler &dof, - const std::map*> &boundary_function, - const Quadrature &q, - std::map &boundary_values, - std::vector component_mapping = std::vector()); + void project_boundary_values + (const DoFHandler &dof, + const std::map*> &boundary_function, + const Quadrature &q, + std::map &boundary_values, + std::vector component_mapping = std::vector()); /** * Same as above, but for objects of type hp::DoFHandler */ template - void project_boundary_values (const hp::MappingCollection &mapping, - const hp::DoFHandler &dof, - const std::map*> &boundary_functions, - const hp::QCollection &q, - std::map &boundary_values, - std::vector component_mapping = std::vector()); + void project_boundary_values + (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const std::map*> &boundary_functions, + const hp::QCollection &q, + std::map &boundary_values, + std::vector component_mapping = std::vector()); /** * Call the project_boundary_values() function, see above, with * mapping=MappingQGeneric@(1). */ template - void project_boundary_values (const hp::DoFHandler &dof, - const std::map*> &boundary_function, - const hp::QCollection &q, - std::map &boundary_values, - std::vector component_mapping = std::vector()); + void project_boundary_values + (const hp::DoFHandler &dof, + const std::map*> &boundary_function, + const hp::QCollection &q, + std::map &boundary_values, + std::vector component_mapping = std::vector()); /** * Project a function to the boundary of the domain, using the given @@ -1237,12 +1241,13 @@ namespace VectorTools * @ingroup constraints */ template - void project_boundary_values (const Mapping &mapping, - const DoFHandler &dof, - const std::map*> &boundary_functions, - const Quadrature &q, - ConstraintMatrix &constraints, - std::vector component_mapping = std::vector()); + void project_boundary_values + (const Mapping &mapping, + const DoFHandler &dof, + const std::map*> &boundary_functions, + const Quadrature &q, + ConstraintMatrix &constraints, + std::vector component_mapping = std::vector()); /** * Call the project_boundary_values() function, see above, with @@ -1251,11 +1256,12 @@ namespace VectorTools * @ingroup constraints */ template - void project_boundary_values (const DoFHandler &dof, - const std::map*> &boundary_function, - const Quadrature &q, - ConstraintMatrix &constraints, - std::vector component_mapping = std::vector()); + void project_boundary_values + (const DoFHandler &dof, + const std::map*> &boundary_function, + const Quadrature &q, + ConstraintMatrix &constraints, + std::vector component_mapping = std::vector()); /** @@ -1313,12 +1319,13 @@ namespace VectorTools * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template - void project_boundary_values_curl_conforming (const DoFHandler &dof_handler, - const unsigned int first_vector_component, - const Function &boundary_function, - const types::boundary_id boundary_component, - ConstraintMatrix &constraints, - const Mapping &mapping = StaticMappingQ1::mapping); + void project_boundary_values_curl_conforming + (const DoFHandler &dof_handler, + const unsigned int first_vector_component, + const Function &boundary_function, + const types::boundary_id boundary_component, + ConstraintMatrix &constraints, + const Mapping &mapping = StaticMappingQ1::mapping); /** * Same as above for the hp-namespace. @@ -1329,12 +1336,13 @@ namespace VectorTools * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template - void project_boundary_values_curl_conforming (const hp::DoFHandler &dof_handler, - const unsigned int first_vector_component, - const Function &boundary_function, - const types::boundary_id boundary_component, - ConstraintMatrix &constraints, - const hp::MappingCollection &mapping_collection = hp::StaticMappingQ1::mapping_collection); + void project_boundary_values_curl_conforming + (const hp::DoFHandler &dof_handler, + const unsigned int first_vector_component, + const Function &boundary_function, + const types::boundary_id boundary_component, + ConstraintMatrix &constraints, + const hp::MappingCollection &mapping_collection = hp::StaticMappingQ1::mapping_collection); /** * This function is an updated version of the @@ -1432,12 +1440,13 @@ namespace VectorTools * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template - void project_boundary_values_curl_conforming_l2 (const DoFHandler &dof_handler, - const unsigned int first_vector_component, - const Function &boundary_function, - const types::boundary_id boundary_component, - ConstraintMatrix &constraints, - const Mapping &mapping = StaticMappingQ1::mapping); + void project_boundary_values_curl_conforming_l2 + (const DoFHandler &dof_handler, + const unsigned int first_vector_component, + const Function &boundary_function, + const types::boundary_id boundary_component, + ConstraintMatrix &constraints, + const Mapping &mapping = StaticMappingQ1::mapping); /** @@ -1447,12 +1456,13 @@ namespace VectorTools * @ingroup constraints */ template - void project_boundary_values_curl_conforming_l2 (const hp::DoFHandler &dof_handler, - const unsigned int first_vector_component, - const Function &boundary_function, - const types::boundary_id boundary_component, - ConstraintMatrix &constraints, - const hp::MappingCollection &mapping_collection = hp::StaticMappingQ1::mapping_collection); + void project_boundary_values_curl_conforming_l2 + (const hp::DoFHandler &dof_handler, + const unsigned int first_vector_component, + const Function &boundary_function, + const types::boundary_id boundary_component, + ConstraintMatrix &constraints, + const hp::MappingCollection &mapping_collection = hp::StaticMappingQ1::mapping_collection); /** @@ -1502,12 +1512,13 @@ namespace VectorTools * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template - void project_boundary_values_div_conforming (const DoFHandler &dof_handler, - const unsigned int first_vector_component, - const Function &boundary_function, - const types::boundary_id boundary_component, - ConstraintMatrix &constraints, - const Mapping &mapping = StaticMappingQ1::mapping); + void project_boundary_values_div_conforming + (const DoFHandler &dof_handler, + const unsigned int first_vector_component, + const Function &boundary_function, + const types::boundary_id boundary_component, + ConstraintMatrix &constraints, + const Mapping &mapping = StaticMappingQ1::mapping); /** * Same as above for the hp-namespace. @@ -1518,12 +1529,14 @@ namespace VectorTools * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template - void project_boundary_values_div_conforming (const hp::DoFHandler &dof_handler, - const unsigned int first_vector_component, - const Function &boundary_function, - const types::boundary_id boundary_component, - ConstraintMatrix &constraints, - const hp::MappingCollection &mapping_collection = hp::StaticMappingQ1::mapping_collection); + void project_boundary_values_div_conforming + (const hp::DoFHandler &dof_handler, + const unsigned int first_vector_component, + const Function &boundary_function, + const types::boundary_id boundary_component, + ConstraintMatrix &constraints, + const hp::MappingCollection &mapping_collection + = hp::StaticMappingQ1::mapping_collection); /** @@ -1837,39 +1850,39 @@ namespace VectorTools */ template void create_right_hand_side (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, - const Function &rhs, - Vector &rhs_vector); + const DoFHandler &dof, + const Quadrature &q, + const Function &rhs, + Vector &rhs_vector); /** * Call the create_right_hand_side() function, see above, with * mapping=MappingQGeneric@(1). */ template - void create_right_hand_side (const DoFHandler &dof, - const Quadrature &q, - const Function &rhs, - Vector &rhs_vector); + void create_right_hand_side (const DoFHandler &dof, + const Quadrature &q, + const Function &rhs, + Vector &rhs_vector); /** * Like the previous set of functions, but for hp objects. */ template - void create_right_hand_side (const hp::MappingCollection &mapping, - const hp::DoFHandler &dof, - const hp::QCollection &q, - const Function &rhs, - Vector &rhs_vector); + void create_right_hand_side (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + const Function &rhs, + Vector &rhs_vector); /** * Like the previous set of functions, but for hp objects. */ template void create_right_hand_side (const hp::DoFHandler &dof, - const hp::QCollection &q, - const Function &rhs, - Vector &rhs_vector); + const hp::QCollection &q, + const Function &rhs, + Vector &rhs_vector); /** * Create a right hand side vector for a point source at point @p p. In @@ -1882,8 +1895,8 @@ namespace VectorTools template void create_point_source_vector(const Mapping &mapping, const DoFHandler &dof, - const Point &p, - Vector &rhs_vector); + const Point &p, + Vector &rhs_vector); /** * Call the create_point_source_vector() function, see above, with @@ -1891,17 +1904,17 @@ namespace VectorTools */ template void create_point_source_vector(const DoFHandler &dof, - const Point &p, - Vector &rhs_vector); + const Point &p, + Vector &rhs_vector); /** * Like the previous set of functions, but for hp objects. */ template - void create_point_source_vector(const hp::MappingCollection &mapping, - const hp::DoFHandler &dof, - const Point &p, - Vector &rhs_vector); + void create_point_source_vector(const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const Point &p, + Vector &rhs_vector); /** * Like the previous set of functions, but for hp objects. The function uses @@ -1911,8 +1924,8 @@ namespace VectorTools */ template void create_point_source_vector(const hp::DoFHandler &dof, - const Point &p, - Vector &rhs_vector); + const Point &p, + Vector &rhs_vector); /** * Create a right hand side vector for a point source at point @p p. This @@ -1995,11 +2008,12 @@ namespace VectorTools * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template - void create_boundary_right_hand_side (const DoFHandler &dof, - const Quadrature &q, - const Function &rhs, - Vector &rhs_vector, - const std::set &boundary_ids = std::set()); + void create_boundary_right_hand_side + (const DoFHandler &dof, + const Quadrature &q, + const Function &rhs, + Vector &rhs_vector, + const std::set &boundary_ids = std::set()); /** * Same as the set of functions above, but for hp objects. @@ -2008,12 +2022,13 @@ namespace VectorTools * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template - void create_boundary_right_hand_side (const hp::MappingCollection &mapping, - const hp::DoFHandler &dof, - const hp::QCollection &q, - const Function &rhs, - Vector &rhs_vector, - const std::set &boundary_ids = std::set()); + void create_boundary_right_hand_side + (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + const Function &rhs, + Vector &rhs_vector, + const std::set &boundary_ids = std::set()); /** * Call the create_boundary_right_hand_side() function, see above, with a @@ -2024,11 +2039,12 @@ namespace VectorTools * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template - void create_boundary_right_hand_side (const hp::DoFHandler &dof, - const hp::QCollection &q, - const Function &rhs, - Vector &rhs_vector, - const std::set &boundary_ids = std::set()); + void create_boundary_right_hand_side + (const hp::DoFHandler &dof, + const hp::QCollection &q, + const Function &rhs, + Vector &rhs_vector, + const std::set &boundary_ids = std::set()); //@} /** @@ -2124,29 +2140,29 @@ namespace VectorTools * Vector. */ template - void integrate_difference (const Mapping &mapping, - const DoFHandler &dof, - const InVector &fe_function, - const Function &exact_solution, - OutVector &difference, - const Quadrature &q, - const NormType &norm, - const Function *weight = 0, - const double exponent = 2.); + void integrate_difference (const Mapping &mapping, + const DoFHandler &dof, + const InVector &fe_function, + const Function &exact_solution, + OutVector &difference, + const Quadrature &q, + const NormType &norm, + const Function *weight = 0, + const double exponent = 2.); /** * Call the integrate_difference() function, see above, with * mapping=MappingQGeneric@(1). */ template - void integrate_difference (const DoFHandler &dof, - const InVector &fe_function, - const Function &exact_solution, - OutVector &difference, - const Quadrature &q, - const NormType &norm, - const Function *weight = 0, - const double exponent = 2.); + void integrate_difference (const DoFHandler &dof, + const InVector &fe_function, + const Function &exact_solution, + OutVector &difference, + const Quadrature &q, + const NormType &norm, + const Function *weight = 0, + const double exponent = 2.); /** * Same as above for hp. @@ -2155,12 +2171,12 @@ namespace VectorTools void integrate_difference (const hp::MappingCollection &mapping, const hp::DoFHandler &dof, const InVector &fe_function, - const Function &exact_solution, + const Function &exact_solution, OutVector &difference, const hp::QCollection &q, const NormType &norm, - const Function *weight = 0, - const double exponent = 2.); + const Function *weight = 0, + const double exponent = 2.); /** * Call the integrate_difference() function, see above, with @@ -2169,12 +2185,12 @@ namespace VectorTools template void integrate_difference (const hp::DoFHandler &dof, const InVector &fe_function, - const Function &exact_solution, + const Function &exact_solution, OutVector &difference, const hp::QCollection &q, const NormType &norm, - const Function *weight = 0, - const double exponent = 2.); + const Function *weight = 0, + const double exponent = 2.); /** * Take a Vector @p cellwise_error of errors on each cell with @@ -2203,9 +2219,9 @@ namespace VectorTools */ template double compute_global_error(const Triangulation &tria, - const InVector &cellwise_error, - const NormType &norm, - const double exponent = 2.); + const InVector &cellwise_error, + const NormType &norm, + const double exponent = 2.); /** * Point error evaluation. Find the first cell containing the given point @@ -2220,11 +2236,12 @@ namespace VectorTools * exception of type VectorTools::ExcPointNotAvailableHere is thrown. */ template - void point_difference (const DoFHandler &dof, - const VectorType &fe_function, - const Function &exact_solution, - Vector &difference, - const Point &point); + void point_difference + (const DoFHandler &dof, + const VectorType &fe_function, + const Function &exact_solution, + Vector &difference, + const Point &point); /** * Point error evaluation. Find the first cell containing the given point @@ -2239,12 +2256,13 @@ namespace VectorTools * exception of type VectorTools::ExcPointNotAvailableHere is thrown. */ template - void point_difference (const Mapping &mapping, - const DoFHandler &dof, - const VectorType &fe_function, - const Function &exact_solution, - Vector &difference, - const Point &point); + void point_difference + (const Mapping &mapping, + const DoFHandler &dof, + const VectorType &fe_function, + const Function &exact_solution, + Vector &difference, + const Point &point); /** * Evaluate a possibly vector-valued finite element function defined by the @@ -2270,10 +2288,10 @@ namespace VectorTools */ template void - point_value (const DoFHandler &dof, - const VectorType &fe_function, - const Point &point, - Vector &value); + point_value (const DoFHandler &dof, + const VectorType &fe_function, + const Point &point, + Vector &value); /** * Same as above for hp. @@ -2294,10 +2312,10 @@ namespace VectorTools */ template void - point_value (const hp::DoFHandler &dof, - const VectorType &fe_function, - const Point &point, - Vector &value); + point_value (const hp::DoFHandler &dof, + const VectorType &fe_function, + const Point &point, + Vector &value); /** * Evaluate a scalar finite element function defined by the given DoFHandler @@ -2378,11 +2396,11 @@ namespace VectorTools */ template void - point_value (const Mapping &mapping, - const DoFHandler &dof, - const VectorType &fe_function, - const Point &point, - Vector &value); + point_value (const Mapping &mapping, + const DoFHandler &dof, + const VectorType &fe_function, + const Point &point, + Vector &value); /** * Same as above for hp. @@ -2407,7 +2425,7 @@ namespace VectorTools const hp::DoFHandler &dof, const VectorType &fe_function, const Point &point, - Vector &value); + Vector &value); /** * Evaluate a scalar finite element function defined by the given DoFHandler @@ -2485,9 +2503,9 @@ namespace VectorTools */ template void - point_gradient (const DoFHandler &dof, - const VectorType &fe_function, - const Point &point, + point_gradient (const DoFHandler &dof, + const VectorType &fe_function, + const Point &point, std::vector > &value); /** @@ -2585,10 +2603,10 @@ namespace VectorTools */ template void - point_gradient (const Mapping &mapping, - const DoFHandler &dof, - const VectorType &fe_function, - const Point &point, + point_gradient (const Mapping &mapping, + const DoFHandler &dof, + const VectorType &fe_function, + const Point &point, std::vector > &value); /** diff --git a/include/deal.II/numerics/vector_tools.templates.h b/include/deal.II/numerics/vector_tools.templates.h index e95fe14037..5e7be2ce0d 100644 --- a/include/deal.II/numerics/vector_tools.templates.h +++ b/include/deal.II/numerics/vector_tools.templates.h @@ -77,11 +77,11 @@ namespace VectorTools template class DoFHandlerType> - void interpolate (const Mapping &mapping, - const DoFHandlerType &dof, - const Function &function, - VectorType &vec, - const ComponentMask &component_mask) + void interpolate (const Mapping &mapping, + const DoFHandlerType &dof, + const Function &function, + VectorType &vec, + const ComponentMask &component_mask) { typedef typename VectorType::value_type number; Assert (component_mask.represents_n_components(dof.get_fe().n_components()), @@ -298,11 +298,11 @@ namespace VectorTools template void - interpolate (const DoFHandler &dof_1, - const DoFHandler &dof_2, - const FullMatrix &transfer, - const InVector &data_1, - OutVector &data_2) + interpolate (const DoFHandler &dof_1, + const DoFHandler &dof_2, + const FullMatrix &transfer, + const InVector &data_1, + OutVector &data_2) { typedef typename OutVector::value_type number; Vector cell_data_1(dof_1.get_fe().dofs_per_cell); @@ -626,9 +626,9 @@ namespace VectorTools void interpolate_to_different_mesh (const InterGridMap > &intergridmap, - const VectorType &u1, - const ConstraintMatrix &constraints, - VectorType &u2) + const VectorType &u1, + const ConstraintMatrix &constraints, + VectorType &u2) { const DoFHandlerType &dof1 = intergridmap.get_source_grid(); const DoFHandlerType &dof2 = intergridmap.get_destination_grid(); @@ -746,8 +746,9 @@ namespace VectorTools * that is already constrained to something else */ template - bool constraints_and_b_v_are_compatible (const ConstraintMatrix &constraints, - std::map &boundary_values) + bool constraints_and_b_v_are_compatible + (const ConstraintMatrix &constraints, + std::map &boundary_values) { for (typename std::map::iterator it=boundary_values.begin(); it != boundary_values.end(); ++it) @@ -763,8 +764,8 @@ namespace VectorTools template void invert_mass_matrix(const SparseMatrix &mass_matrix, - const Vector &rhs, - Vector &solution) + const Vector &rhs, + Vector &solution) { // Allow for a maximum of 5*n steps to reduce the residual by 10^-12. n // steps may not be sufficient, since roundoff errors may accumulate for @@ -798,7 +799,7 @@ namespace VectorTools const DoFHandlerType &dof, const ConstraintMatrix &constraints, const Q_or_QC &quadrature, - const Function &function, + const Function &function, VectorType &vec_result, const bool enforce_zero_boundary, const Q_or_QC &q_boundary, @@ -877,7 +878,7 @@ namespace VectorTools const DoFHandler &dof, const ConstraintMatrix &constraints, const Quadrature &quadrature, - const Function &function, + const Function &function, VectorType &vec_result, const bool enforce_zero_boundary, const Quadrature &q_boundary, @@ -894,11 +895,11 @@ namespace VectorTools void project (const DoFHandler &dof, const ConstraintMatrix &constraints, const Quadrature &quadrature, - const Function &function, + const Function &function, VectorType &vec, - const bool enforce_zero_boundary, + const bool enforce_zero_boundary, const Quadrature &q_boundary, - const bool project_to_boundary_first) + const bool project_to_boundary_first) { project(StaticMappingQ1::mapping, dof, constraints, quadrature, function, vec, enforce_zero_boundary, q_boundary, project_to_boundary_first); @@ -911,11 +912,11 @@ namespace VectorTools const hp::DoFHandler &dof, const ConstraintMatrix &constraints, const hp::QCollection &quadrature, - const Function &function, + const Function &function, VectorType &vec_result, - const bool enforce_zero_boundary, + const bool enforce_zero_boundary, const hp::QCollection &q_boundary, - const bool project_to_boundary_first) + const bool project_to_boundary_first) { do_project (mapping, dof, constraints, quadrature, function, vec_result, @@ -928,11 +929,11 @@ namespace VectorTools void project (const hp::DoFHandler &dof, const ConstraintMatrix &constraints, const hp::QCollection &quadrature, - const Function &function, + const Function &function, VectorType &vec, - const bool enforce_zero_boundary, + const bool enforce_zero_boundary, const hp::QCollection &q_boundary, - const bool project_to_boundary_first) + const bool project_to_boundary_first) { project(hp::StaticMappingQ1::mapping_collection, dof, constraints, quadrature, function, vec, @@ -941,11 +942,11 @@ namespace VectorTools template - void create_right_hand_side (const Mapping &mapping, + void create_right_hand_side (const Mapping &mapping, const DoFHandler &dof_handler, - const Quadrature &quadrature, - const Function &rhs_function, - Vector &rhs_vector) + const Quadrature &quadrature, + const Function &rhs_function, + Vector &rhs_vector) { const FiniteElement &fe = dof_handler.get_fe(); Assert (fe.n_components() == rhs_function.n_components, @@ -1052,10 +1053,10 @@ namespace VectorTools template - void create_right_hand_side (const DoFHandler &dof_handler, - const Quadrature &quadrature, - const Function &rhs_function, - Vector &rhs_vector) + void create_right_hand_side (const DoFHandler &dof_handler, + const Quadrature &quadrature, + const Function &rhs_function, + Vector &rhs_vector) { create_right_hand_side(StaticMappingQ1::mapping, dof_handler, quadrature, rhs_function, rhs_vector); @@ -1065,11 +1066,11 @@ namespace VectorTools template - void create_right_hand_side (const hp::MappingCollection &mapping, - const hp::DoFHandler &dof_handler, - const hp::QCollection &quadrature, - const Function &rhs_function, - Vector &rhs_vector) + void create_right_hand_side (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof_handler, + const hp::QCollection &quadrature, + const Function &rhs_function, + Vector &rhs_vector) { const hp::FECollection &fe = dof_handler.get_fe(); Assert (fe.n_components() == rhs_function.n_components, @@ -1190,10 +1191,10 @@ namespace VectorTools template - void create_right_hand_side (const hp::DoFHandler &dof_handler, - const hp::QCollection &quadrature, - const Function &rhs_function, - Vector &rhs_vector) + void create_right_hand_side (const hp::DoFHandler &dof_handler, + const hp::QCollection &quadrature, + const Function &rhs_function, + Vector &rhs_vector) { create_right_hand_side(hp::StaticMappingQ1::mapping_collection, dof_handler, quadrature, @@ -1204,10 +1205,10 @@ namespace VectorTools template - void create_point_source_vector (const Mapping &mapping, - const DoFHandler &dof_handler, - const Point &p, - Vector &rhs_vector) + void create_point_source_vector (const Mapping &mapping, + const DoFHandler &dof_handler, + const Point &p, + Vector &rhs_vector) { Assert (rhs_vector.size() == dof_handler.n_dofs(), ExcDimensionMismatch(rhs_vector.size(), dof_handler.n_dofs())); @@ -1238,9 +1239,9 @@ namespace VectorTools template - void create_point_source_vector (const DoFHandler &dof_handler, - const Point &p, - Vector &rhs_vector) + void create_point_source_vector (const DoFHandler &dof_handler, + const Point &p, + Vector &rhs_vector) { create_point_source_vector(StaticMappingQ1::mapping, dof_handler, p, rhs_vector); @@ -1248,10 +1249,10 @@ namespace VectorTools template - void create_point_source_vector (const hp::MappingCollection &mapping, - const hp::DoFHandler &dof_handler, - const Point &p, - Vector &rhs_vector) + void create_point_source_vector (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof_handler, + const Point &p, + Vector &rhs_vector) { Assert (rhs_vector.size() == dof_handler.n_dofs(), ExcDimensionMismatch(rhs_vector.size(), dof_handler.n_dofs())); @@ -1282,9 +1283,9 @@ namespace VectorTools template - void create_point_source_vector (const hp::DoFHandler &dof_handler, - const Point &p, - Vector &rhs_vector) + void create_point_source_vector (const hp::DoFHandler &dof_handler, + const Point &p, + Vector &rhs_vector) { create_point_source_vector(hp::StaticMappingQ1::mapping_collection, dof_handler, @@ -1295,11 +1296,11 @@ namespace VectorTools template - void create_point_source_vector (const Mapping &mapping, - const DoFHandler &dof_handler, - const Point &p, - const Point &orientation, - Vector &rhs_vector) + void create_point_source_vector (const Mapping &mapping, + const DoFHandler &dof_handler, + const Point &p, + const Point &orientation, + Vector &rhs_vector) { Assert (rhs_vector.size() == dof_handler.n_dofs(), ExcDimensionMismatch(rhs_vector.size(), dof_handler.n_dofs())); @@ -1331,10 +1332,10 @@ namespace VectorTools template - void create_point_source_vector (const DoFHandler &dof_handler, - const Point &p, - const Point &orientation, - Vector &rhs_vector) + void create_point_source_vector (const DoFHandler &dof_handler, + const Point &p, + const Point &orientation, + Vector &rhs_vector) { create_point_source_vector(StaticMappingQ1::mapping, dof_handler, p, orientation, rhs_vector); @@ -1378,10 +1379,10 @@ namespace VectorTools template - void create_point_source_vector (const hp::DoFHandler &dof_handler, - const Point &p, - const Point &orientation, - Vector &rhs_vector) + void create_point_source_vector (const hp::DoFHandler &dof_handler, + const Point &p, + const Point &orientation, + Vector &rhs_vector) { create_point_source_vector(hp::StaticMappingQ1::mapping_collection, dof_handler, @@ -1392,11 +1393,11 @@ namespace VectorTools template void - create_boundary_right_hand_side (const Mapping &mapping, - const DoFHandler &dof_handler, - const Quadrature &quadrature, - const Function &rhs_function, - Vector &rhs_vector, + create_boundary_right_hand_side (const Mapping &mapping, + const DoFHandler &dof_handler, + const Quadrature &quadrature, + const Function &rhs_function, + Vector &rhs_vector, const std::set &boundary_ids) { const FiniteElement &fe = dof_handler.get_fe(); @@ -1515,10 +1516,10 @@ namespace VectorTools template void - create_boundary_right_hand_side (const DoFHandler &dof_handler, - const Quadrature &quadrature, - const Function &rhs_function, - Vector &rhs_vector, + create_boundary_right_hand_side (const DoFHandler &dof_handler, + const Quadrature &quadrature, + const Function &rhs_function, + Vector &rhs_vector, const std::set &boundary_ids) { create_boundary_right_hand_side(StaticMappingQ1::mapping, dof_handler, @@ -1532,11 +1533,11 @@ namespace VectorTools template void create_boundary_right_hand_side (const hp::MappingCollection &mapping, - const hp::DoFHandler &dof_handler, - const hp::QCollection &quadrature, - const Function &rhs_function, - Vector &rhs_vector, - const std::set &boundary_ids) + const hp::DoFHandler &dof_handler, + const hp::QCollection &quadrature, + const Function &rhs_function, + Vector &rhs_vector, + const std::set &boundary_ids) { const hp::FECollection &fe = dof_handler.get_fe(); Assert (fe.n_components() == rhs_function.n_components, @@ -1667,9 +1668,9 @@ namespace VectorTools template void create_boundary_right_hand_side (const hp::DoFHandler &dof_handler, - const hp::QCollection &quadrature, - const Function &rhs_function, - Vector &rhs_vector, + const hp::QCollection &quadrature, + const Function &rhs_function, + Vector &rhs_vector, const std::set &boundary_ids) { create_boundary_right_hand_side(hp::StaticMappingQ1::mapping_collection, @@ -2185,11 +2186,11 @@ namespace VectorTools template - void invert_mass_matrix(const SparseMatrix &mass_matrix, + void invert_mass_matrix(const SparseMatrix &mass_matrix, const FilteredMatrix > &filtered_mass_matrix, - FilteredMatrix > &filtered_preconditioner, - const Vector &rhs, - Vector &boundary_projection) + FilteredMatrix > &filtered_preconditioner, + const Vector &rhs, + Vector &boundary_projection) { // Allow for a maximum of 5*n steps to reduce the residual by 10^-12. n // steps may not be sufficient, since roundoff errors may accumulate for @@ -2208,11 +2209,12 @@ namespace VectorTools } template - void invert_mass_matrix(const SparseMatrix > &/*mass_matrix*/, - const FilteredMatrix > > &/*filtered_mass_matrix*/, - FilteredMatrix > > &/*filtered_preconditioner*/, - const Vector > &/*rhs*/, - Vector > &/*boundary_projection*/) + void invert_mass_matrix + (const SparseMatrix > &/*mass_matrix*/, + const FilteredMatrix > > &/*filtered_mass_matrix*/, + FilteredMatrix > > &/*filtered_preconditioner*/, + const Vector > &/*rhs*/, + Vector > &/*boundary_projection*/) { Assert(false, ExcNotImplemented()); } @@ -2221,12 +2223,13 @@ namespace VectorTools template class DoFHandlerType, template class M_or_MC, template class Q_or_QC, typename number> void - do_project_boundary_values (const M_or_MC &mapping, - const DoFHandlerType &dof, - const std::map*> &boundary_functions, - const Q_or_QC &q, - std::map &boundary_values, - std::vector component_mapping) + do_project_boundary_values + (const M_or_MC &mapping, + const DoFHandlerType &dof, + const std::map*> &boundary_functions, + const Q_or_QC &q, + std::map &boundary_values, + std::vector component_mapping) { // in 1d, projection onto the 0d end points == interpolation if (dim == 1) @@ -2404,12 +2407,13 @@ namespace VectorTools template void - project_boundary_values (const Mapping &mapping, - const DoFHandler &dof, - const std::map*> &boundary_functions, - const Quadrature &q, - std::map &boundary_values, - std::vector component_mapping) + project_boundary_values + (const Mapping &mapping, + const DoFHandler &dof, + const std::map*> &boundary_functions, + const Quadrature &q, + std::map &boundary_values, + std::vector component_mapping) { do_project_boundary_values(mapping, dof, boundary_functions, q, boundary_values, component_mapping); @@ -2419,11 +2423,12 @@ namespace VectorTools template void - project_boundary_values (const DoFHandler &dof, - const std::map*> &boundary_functions, - const Quadrature &q, - std::map &boundary_values, - std::vector component_mapping) + project_boundary_values + (const DoFHandler &dof, + const std::map*> &boundary_functions, + const Quadrature &q, + std::map &boundary_values, + std::vector component_mapping) { project_boundary_values(StaticMappingQ1::mapping, dof, boundary_functions, q, boundary_values, component_mapping); @@ -2432,12 +2437,13 @@ namespace VectorTools template - void project_boundary_values (const hp::MappingCollection &mapping, - const hp::DoFHandler &dof, - const std::map*> &boundary_functions, - const hp::QCollection &q, - std::map &boundary_values, - std::vector component_mapping) + void project_boundary_values + (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const std::map*> &boundary_functions, + const hp::QCollection &q, + std::map &boundary_values, + std::vector component_mapping) { do_project_boundary_values (mapping, dof, boundary_functions, @@ -2448,11 +2454,12 @@ namespace VectorTools template - void project_boundary_values (const hp::DoFHandler &dof, - const std::map*> &boundary_function, - const hp::QCollection &q, - std::map &boundary_values, - std::vector component_mapping) + void project_boundary_values + (const hp::DoFHandler &dof, + const std::map*> &boundary_function, + const hp::QCollection &q, + std::map &boundary_values, + std::vector component_mapping) { project_boundary_values (hp::StaticMappingQ1::mapping_collection, dof, boundary_function, @@ -2467,12 +2474,13 @@ namespace VectorTools template void - project_boundary_values (const Mapping &mapping, - const DoFHandler &dof, - const std::map*> &boundary_functions, - const Quadrature &q, - ConstraintMatrix &constraints, - std::vector component_mapping) + project_boundary_values + (const Mapping &mapping, + const DoFHandler &dof, + const std::map*> &boundary_functions, + const Quadrature &q, + ConstraintMatrix &constraints, + std::vector component_mapping) { std::map boundary_values; project_boundary_values (mapping, dof, boundary_functions, q, @@ -2494,11 +2502,12 @@ namespace VectorTools template void - project_boundary_values (const DoFHandler &dof, - const std::map*> &boundary_functions, - const Quadrature &q, - ConstraintMatrix &constraints, - std::vector component_mapping) + project_boundary_values + (const DoFHandler &dof, + const std::map*> &boundary_functions, + const Quadrature &q, + ConstraintMatrix &constraints, + std::vector component_mapping) { project_boundary_values(StaticMappingQ1::mapping, dof, boundary_functions, q, constraints, component_mapping); @@ -2552,7 +2561,7 @@ namespace VectorTools template - std::ostream &operator << (std::ostream &out, + std::ostream &operator << (std::ostream &out, const VectorDoFTuple &vdt) { for (unsigned int d=0; d &dof_indices, const Tensor<1,dim> &constraining_vector, ConstraintMatrix &constraints, - const double inhomogeneity=0) + const double inhomogeneity=0) { // choose the DoF that has the @@ -2960,13 +2969,13 @@ namespace VectorTools template void compute_edge_projection (const cell_iterator &cell, - const unsigned int face, - const unsigned int line, - hp::FEValues<3> &hp_fe_values, - const Function<3> &boundary_function, - const unsigned int first_vector_component, + const unsigned int face, + const unsigned int line, + hp::FEValues<3> &hp_fe_values, + const Function<3> &boundary_function, + const unsigned int first_vector_component, std::vector &dof_values, - std::vector &dofs_processed) + std::vector &dofs_processed) { const double tol = 0.5 * cell->face (face)->line (line)->diameter () / cell->get_fe ().degree; const unsigned int dim = 3; @@ -3121,12 +3130,12 @@ namespace VectorTools template void compute_face_projection_curl_conforming (const cell_iterator &cell, - const unsigned int face, - hp::FEValues &hp_fe_values, + const unsigned int face, + hp::FEValues &hp_fe_values, const Function &boundary_function, - const unsigned int first_vector_component, + const unsigned int first_vector_component, std::vector &dof_values, - std::vector &dofs_processed) + std::vector &dofs_processed) { const unsigned int spacedim = dim; hp_fe_values.reinit (cell, cell->active_fe_index () @@ -3497,12 +3506,12 @@ namespace VectorTools template void - project_boundary_values_curl_conforming (const DoFHandler &dof_handler, - const unsigned int first_vector_component, - const Function &boundary_function, - const types::boundary_id boundary_component, - ConstraintMatrix &constraints, - const Mapping &mapping) + project_boundary_values_curl_conforming (const DoFHandler &dof_handler, + const unsigned int first_vector_component, + const Function &boundary_function, + const types::boundary_id boundary_component, + ConstraintMatrix &constraints, + const Mapping &mapping) { // Projection-based interpolation is performed in two (in 2D) respectively // three (in 3D) steps. First the tangential component of the function is @@ -3713,12 +3722,13 @@ namespace VectorTools template void - project_boundary_values_curl_conforming (const hp::DoFHandler &dof_handler, - const unsigned int first_vector_component, - const Function &boundary_function, - const types::boundary_id boundary_component, - ConstraintMatrix &constraints, - const hp::MappingCollection &mapping_collection) + project_boundary_values_curl_conforming + (const hp::DoFHandler &dof_handler, + const unsigned int first_vector_component, + const Function &boundary_function, + const types::boundary_id boundary_component, + ConstraintMatrix &constraints, + const hp::MappingCollection &mapping_collection) { hp::FECollection fe_collection (dof_handler.get_fe ()); hp::QCollection face_quadrature_collection; @@ -3904,13 +3914,13 @@ namespace VectorTools template void compute_edge_projection_l2 (const cell_iterator &cell, - const unsigned int face, - const unsigned int line, - hp::FEValues<3> &hp_fe_values, - const Function<3> &boundary_function, - const unsigned int first_vector_component, + const unsigned int face, + const unsigned int line, + hp::FEValues<3> &hp_fe_values, + const Function<3> &boundary_function, + const unsigned int first_vector_component, std::vector &dof_values, - std::vector &dofs_processed) + std::vector &dofs_processed) { // This function computes the L2-projection of the given // boundary function on 3D edges and returns the constraints @@ -4146,13 +4156,14 @@ namespace VectorTools template void - compute_face_projection_curl_conforming_l2 (const cell_iterator &cell, - const unsigned int face, - hp::FEFaceValues &hp_fe_face_values, - const Function &boundary_function, - const unsigned int first_vector_component, - std::vector &dof_values, - std::vector &dofs_processed) + compute_face_projection_curl_conforming_l2 + (const cell_iterator &cell, + const unsigned int face, + hp::FEFaceValues &hp_fe_face_values, + const Function &boundary_function, + const unsigned int first_vector_component, + std::vector &dof_values, + std::vector &dofs_processed) { // This function computes the L2-projection of the boundary // function on the interior of faces only. In 3D, this should only be @@ -4745,12 +4756,13 @@ namespace VectorTools template void - project_boundary_values_curl_conforming_l2 (const DoFHandler &dof_handler, - const unsigned int first_vector_component, - const Function &boundary_function, - const types::boundary_id boundary_component, - ConstraintMatrix &constraints, - const Mapping &mapping) + project_boundary_values_curl_conforming_l2 + (const DoFHandler &dof_handler, + const unsigned int first_vector_component, + const Function &boundary_function, + const types::boundary_id boundary_component, + ConstraintMatrix &constraints, + const Mapping &mapping) { // non-hp version - calls the internal // compute_project_boundary_values_curl_conforming_l2() function @@ -4768,12 +4780,13 @@ namespace VectorTools template void - project_boundary_values_curl_conforming_l2 (const hp::DoFHandler &dof_handler, - const unsigned int first_vector_component, - const Function &boundary_function, - const types::boundary_id boundary_component, - ConstraintMatrix &constraints, - const hp::MappingCollection &mapping_collection) + project_boundary_values_curl_conforming_l2 + (const hp::DoFHandler &dof_handler, + const unsigned int first_vector_component, + const Function &boundary_function, + const types::boundary_id boundary_component, + ConstraintMatrix &constraints, + const hp::MappingCollection &mapping_collection) { // hp version - calls the internal // compute_project_boundary_values_curl_conforming_l2() function above. @@ -4794,13 +4807,14 @@ namespace VectorTools // boundary in 2d. template void - compute_face_projection_div_conforming (const cell_iterator &cell, - const unsigned int face, - const FEFaceValues<2> &fe_values, - const unsigned int first_vector_component, - const Function<2> &boundary_function, - const std::vector > &jacobians, - ConstraintMatrix &constraints) + compute_face_projection_div_conforming + (const cell_iterator &cell, + const unsigned int face, + const FEFaceValues<2> &fe_values, + const unsigned int first_vector_component, + const Function<2> &boundary_function, + const std::vector > &jacobians, + ConstraintMatrix &constraints) { // Compute the intergral over the product of the normal components of // the boundary function times the normal components of the shape @@ -4874,14 +4888,15 @@ namespace VectorTools // boundary in 3d. template void - compute_face_projection_div_conforming (const cell_iterator &cell, - const unsigned int face, - const FEFaceValues<3> &fe_values, - const unsigned int first_vector_component, - const Function<3> &boundary_function, - const std::vector > &jacobians, - std::vector &dof_values, - std::vector &projected_dofs) + compute_face_projection_div_conforming + (const cell_iterator &cell, + const unsigned int face, + const FEFaceValues<3> &fe_values, + const unsigned int first_vector_component, + const Function<3> &boundary_function, + const std::vector > &jacobians, + std::vector &dof_values, + std::vector &projected_dofs) { // Compute the intergral over the product of the normal components of // the boundary function times the normal components of the shape @@ -4967,12 +4982,12 @@ namespace VectorTools template void - project_boundary_values_div_conforming (const DoFHandler &dof_handler, - const unsigned int first_vector_component, - const Function &boundary_function, - const types::boundary_id boundary_component, - ConstraintMatrix &constraints, - const Mapping &mapping) + project_boundary_values_div_conforming (const DoFHandler &dof_handler, + const unsigned int first_vector_component, + const Function &boundary_function, + const types::boundary_id boundary_component, + ConstraintMatrix &constraints, + const Mapping &mapping) { const unsigned int spacedim = dim; // Interpolate the normal components @@ -5133,12 +5148,13 @@ namespace VectorTools template void - project_boundary_values_div_conforming (const hp::DoFHandler &dof_handler, - const unsigned int first_vector_component, - const Function &boundary_function, - const types::boundary_id boundary_component, - ConstraintMatrix &constraints, - const hp::MappingCollection &mapping_collection) + project_boundary_values_div_conforming + (const hp::DoFHandler &dof_handler, + const unsigned int first_vector_component, + const Function &boundary_function, + const types::boundary_id boundary_component, + ConstraintMatrix &constraints, + const hp::MappingCollection &mapping_collection) { const unsigned int spacedim = dim; const hp::FECollection &fe_collection = dof_handler.get_fe (); @@ -6553,15 +6569,15 @@ namespace VectorTools template void - integrate_difference (const Mapping &mapping, + integrate_difference (const Mapping &mapping, const DoFHandler &dof, - const InVector &fe_function, - const Function &exact_solution, - OutVector &difference, - const Quadrature &q, - const NormType &norm, - const Function *weight, - const double exponent) + const InVector &fe_function, + const Function &exact_solution, + OutVector &difference, + const Quadrature &q, + const NormType &norm, + const Function *weight, + const double exponent) { internal ::do_integrate_difference (hp::MappingCollection(mapping), @@ -6573,14 +6589,14 @@ namespace VectorTools template void - integrate_difference (const DoFHandler &dof, - const InVector &fe_function, - const Function &exact_solution, - OutVector &difference, - const Quadrature &q, - const NormType &norm, - const Function *weight, - const double exponent) + integrate_difference (const DoFHandler &dof, + const InVector &fe_function, + const Function &exact_solution, + OutVector &difference, + const Quadrature &q, + const NormType &norm, + const Function *weight, + const double exponent) { internal ::do_integrate_difference(hp::StaticMappingQ1::mapping_collection, @@ -6593,15 +6609,15 @@ namespace VectorTools template void - integrate_difference (const dealii::hp::MappingCollection &mapping, - const dealii::hp::DoFHandler &dof, - const InVector &fe_function, - const Function &exact_solution, - OutVector &difference, - const dealii::hp::QCollection &q, - const NormType &norm, - const Function *weight, - const double exponent) + integrate_difference (const dealii::hp::MappingCollection &mapping, + const dealii::hp::DoFHandler &dof, + const InVector &fe_function, + const Function &exact_solution, + OutVector &difference, + const dealii::hp::QCollection &q, + const NormType &norm, + const Function *weight, + const double exponent) { internal ::do_integrate_difference (hp::MappingCollection(mapping), @@ -6613,14 +6629,14 @@ namespace VectorTools template void - integrate_difference (const dealii::hp::DoFHandler &dof, - const InVector &fe_function, - const Function &exact_solution, - OutVector &difference, - const dealii::hp::QCollection &q, - const NormType &norm, - const Function *weight, - const double exponent) + integrate_difference (const dealii::hp::DoFHandler &dof, + const InVector &fe_function, + const Function &exact_solution, + OutVector &difference, + const dealii::hp::QCollection &q, + const NormType &norm, + const Function *weight, + const double exponent) { internal ::do_integrate_difference(hp::StaticMappingQ1::mapping_collection, @@ -6631,9 +6647,9 @@ namespace VectorTools template double compute_global_error(const Triangulation &tria, - const InVector &cellwise_error, - const NormType &norm, - const double exponent) + const InVector &cellwise_error, + const NormType &norm, + const double exponent) { Assert( cellwise_error.size() == tria.n_active_cells(), ExcMessage("input vector cell_error has invalid size!")); @@ -6723,11 +6739,11 @@ namespace VectorTools template void - point_difference (const DoFHandler &dof, - const VectorType &fe_function, - const Function &exact_function, - Vector &difference, - const Point &point) + point_difference (const DoFHandler &dof, + const VectorType &fe_function, + const Function &exact_function, + Vector &difference, + const Point &point) { point_difference(StaticMappingQ1::mapping, dof, @@ -6740,12 +6756,12 @@ namespace VectorTools template void - point_difference (const Mapping &mapping, - const DoFHandler &dof, - const VectorType &fe_function, - const Function &exact_function, - Vector &difference, - const Point &point) + point_difference (const Mapping &mapping, + const DoFHandler &dof, + const VectorType &fe_function, + const Function &exact_function, + Vector &difference, + const Point &point) { typedef typename VectorType::value_type Number; const FiniteElement &fe = dof.get_fe(); @@ -6786,10 +6802,10 @@ namespace VectorTools template void - point_value (const DoFHandler &dof, - const VectorType &fe_function, - const Point &point, - Vector &value) + point_value (const DoFHandler &dof, + const VectorType &fe_function, + const Point &point, + Vector &value) { point_value (StaticMappingQ1::mapping, @@ -6802,10 +6818,10 @@ namespace VectorTools template void - point_value (const hp::DoFHandler &dof, - const VectorType &fe_function, - const Point &point, - Vector &value) + point_value (const hp::DoFHandler &dof, + const VectorType &fe_function, + const Point &point, + Vector &value) { point_value(hp::StaticMappingQ1::mapping_collection, dof, @@ -6843,11 +6859,11 @@ namespace VectorTools template void - point_value (const Mapping &mapping, - const DoFHandler &dof, - const VectorType &fe_function, - const Point &point, - Vector &value) + point_value (const Mapping &mapping, + const DoFHandler &dof, + const VectorType &fe_function, + const Point &point, + Vector &value) { typedef typename VectorType::value_type Number; const FiniteElement &fe = dof.get_fe(); @@ -6888,7 +6904,7 @@ namespace VectorTools const hp::DoFHandler &dof, const VectorType &fe_function, const Point &point, - Vector &value) + Vector &value) { typedef typename VectorType::value_type Number; const hp::FECollection &fe = dof.get_fe(); @@ -7200,7 +7216,7 @@ namespace VectorTools const DoFHandler &dof, const Quadrature &quadrature, const VectorType &v, - const unsigned int component) + const unsigned int component) { typedef typename VectorType::value_type Number; Assert (v.size() == dof.n_dofs(), @@ -7266,7 +7282,7 @@ namespace VectorTools compute_mean_value (const DoFHandler &dof, const Quadrature &quadrature, const VectorType &v, - const unsigned int component) + const unsigned int component) { return compute_mean_value(StaticMappingQ1::mapping, dof, quadrature, v, component); }