From: Wolfgang Bangerth Date: Sat, 1 Aug 2009 16:42:10 +0000 (+0000) Subject: Reindent -- there were vestiges from the change to dim/spacedim that X-Git-Tag: v8.0.0~7404 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=cb0eb4e44678f32b8965738114ac309b69ad40a7;p=dealii.git Reindent -- there were vestiges from the change to dim/spacedim that hadn't been re-indented back then. git-svn-id: https://svn.dealii.org/trunk@19161 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/deal.II/source/fe/fe_values.cc b/deal.II/deal.II/source/fe/fe_values.cc index db9a1eecd9..333157f2a3 100644 --- a/deal.II/deal.II/source/fe/fe_values.cc +++ b/deal.II/deal.II/source/fe/fe_values.cc @@ -345,7 +345,7 @@ namespace FEValuesViews const Tensor<2,spacedim> * shape_hessian_ptr = &fe_values.shape_hessians[shape_function_data[shape_function]. - row_index][0]; + row_index][0]; for (unsigned int q_point=0; q_point * shape_gradient_ptr = &fe_values.shape_gradients[shape_function_data[shape_function]. - row_index[d]][0]; + row_index[d]][0]; for (unsigned int q_point=0; q_point:: get_function_symmetric_gradients (const InputVector &fe_function, - std::vector &symmetric_gradients) const + std::vector &symmetric_gradients) const { typedef FEValuesBase FVB; Assert (fe_values.update_flags & update_gradients, @@ -1626,8 +1626,8 @@ get_interpolated_dof_values (const TrilinosWrappers::MPI::BlockVector &, template void FEValuesData::initialize (const unsigned int n_quadrature_points, - const FiniteElement &fe, - const UpdateFlags flags) + const FiniteElement &fe, + const UpdateFlags flags) { this->update_flags = flags; @@ -1662,7 +1662,7 @@ FEValuesData::initialize (const unsigned int n_quadrature_p if (flags & update_hessians) this->shape_hessians.resize (n_nonzero_shape_components, - std::vector > (n_quadrature_points)); + std::vector > (n_quadrature_points)); if (flags & update_quadrature_points) this->quadrature_points.resize(n_quadrature_points); @@ -1696,10 +1696,10 @@ FEValuesData::initialize (const unsigned int n_quadrature_p template FEValuesBase::FEValuesBase (const unsigned int n_q_points, - const unsigned int dofs_per_cell, - const UpdateFlags flags, - const Mapping &mapping, - const FiniteElement &fe) + const unsigned int dofs_per_cell, + const UpdateFlags flags, + const Mapping &mapping, + const FiniteElement &fe) : n_quadrature_points (n_q_points), dofs_per_cell (dofs_per_cell), @@ -1927,29 +1927,29 @@ void FEValuesBase::get_function_values ( if (fe->is_primitive(shape_func)) { - // compared to the scalar - // functions, finding the correct - // index in the shape_value table - // is more involved, since we have - // to find the row in shape_values - // that corresponds to the present - // shape_func. this is done - // manually in the same way as in - // shape_value_component() (that - // function can't be used because - // it doesn't return us a pointer - // to the data). + // compared to the scalar + // functions, finding the correct + // index in the shape_value table + // is more involved, since we have + // to find the row in shape_values + // that corresponds to the present + // shape_func. this is done + // manually in the same way as in + // shape_value_component() (that + // function can't be used because + // it doesn't return us a pointer + // to the data). const unsigned int row = fe->is_primitive() ? - shape_func : this->shape_function_to_row_table[shape_func]; + shape_func : this->shape_function_to_row_table[shape_func]; const double *shape_value_ptr = &this->shape_values(row, 0); const unsigned int comp = fe->system_to_component_index(shape_func).first; for (unsigned int point=0; point::get_function_values ( { const unsigned int row = fe->is_primitive() ? - shape_func : this->shape_function_to_row_table[shape_func]; + shape_func : this->shape_function_to_row_table[shape_func]; const double *shape_value_ptr = &this->shape_values(row, 0); const unsigned int comp = fe->system_to_component_index(shape_func).first - + mc * n_components; + + mc * n_components; for (unsigned int point=0; point::get_function_values ( { const unsigned int row = fe->is_primitive() ? - shape_func : this->shape_function_to_row_table[shape_func]; + shape_func : this->shape_function_to_row_table[shape_func]; const double *shape_value_ptr = &this->shape_values(row, 0); const unsigned int comp = fe->system_to_component_index(shape_func).first - + mc * n_components; + + mc * n_components; if (quadrature_points_fastest) for (unsigned int point=0; point::get_function_gradients ( { const unsigned int row = fe->is_primitive() ? - shape_func : this->shape_function_to_row_table[shape_func]; + shape_func : this->shape_function_to_row_table[shape_func]; const Tensor<1,spacedim> *shape_gradient_ptr = &this->shape_gradients[row][0]; const unsigned int comp = fe->system_to_component_index(shape_func).first; @@ -2453,18 +2453,18 @@ void FEValuesBase::get_function_gradients ( { const unsigned int row = fe->is_primitive() ? - shape_func : this->shape_function_to_row_table[shape_func]; + shape_func : this->shape_function_to_row_table[shape_func]; const Tensor<1,spacedim> *shape_gradient_ptr = &this->shape_gradients[row][0]; const unsigned int comp = fe->system_to_component_index(shape_func).first - + mc * n_components; + + mc * n_components; - if (quadrature_points_fastest) - for (unsigned int point=0; pointis_primitive() ? - shape_func : this->shape_function_to_row_table[shape_func]; + shape_func : this->shape_function_to_row_table[shape_func]; const Tensor<2,spacedim> *shape_hessian_ptr = &this->shape_hessians[row][0]; @@ -2744,19 +2744,19 @@ void FEValuesBase::get_function_hessians ( { const unsigned int row = fe->is_primitive() ? - shape_func : this->shape_function_to_row_table[shape_func]; + shape_func : this->shape_function_to_row_table[shape_func]; const Tensor<2,spacedim> *shape_hessian_ptr = &this->shape_hessians[row][0]; const unsigned int comp = fe->system_to_component_index(shape_func).first - + mc * n_components; + + mc * n_components; - if (quadrature_points_fastest) - for (unsigned int point=0; point::get_function_laplacians ( { const unsigned int row = fe->is_primitive() ? - shape_func : this->shape_function_to_row_table[shape_func]; + shape_func : this->shape_function_to_row_table[shape_func]; const Tensor<2,spacedim> *shape_hessian_ptr = &this->shape_hessians[row][0]; @@ -3030,12 +3030,12 @@ void FEValuesBase::get_function_laplacians ( { const unsigned int row = fe->is_primitive() ? - shape_func : this->shape_function_to_row_table[shape_func]; + shape_func : this->shape_function_to_row_table[shape_func]; const Tensor<2,spacedim> *shape_hessian_ptr = &this->shape_hessians[row][0]; const unsigned int comp = fe->system_to_component_index(shape_func).first - + mc * n_components; + + mc * n_components; for (unsigned int point=0; point::get_function_laplacians ( { const unsigned int row = fe->is_primitive() ? - shape_func : this->shape_function_to_row_table[shape_func]; + shape_func : this->shape_function_to_row_table[shape_func]; const Tensor<2,spacedim> *shape_hessian_ptr = &this->shape_hessians[row][0]; const unsigned int comp = fe->system_to_component_index(shape_func).first - + mc * n_components; + + mc * n_components; if (quadrature_points_fastest) for (unsigned int point=0; point inline void FEValuesBase::check_cell_similarity - (const typename Triangulation::cell_iterator &cell) +(const typename Triangulation::cell_iterator &cell) { // case that there has not been any cell // before @@ -3559,10 +3559,10 @@ FEFaceValuesBase::FEFaceValuesBase (const unsigned int n_q_points, const Quadrature& quadrature) : FEValuesBase (n_q_points, - dofs_per_cell, - update_default, - mapping, - fe), + dofs_per_cell, + update_default, + mapping, + fe), quadrature(quadrature) {} @@ -3612,15 +3612,15 @@ const unsigned int FEFaceValues::integral_dimension; template FEFaceValues::FEFaceValues (const Mapping &mapping, - const FiniteElement &fe, - const Quadrature &quadrature, - const UpdateFlags update_flags) + const FiniteElement &fe, + const Quadrature &quadrature, + const UpdateFlags update_flags) : FEFaceValuesBase (quadrature.size(), - fe.dofs_per_cell, - update_flags, - mapping, - fe, quadrature) + fe.dofs_per_cell, + update_flags, + mapping, + fe, quadrature) { initialize (update_flags); } @@ -3629,14 +3629,14 @@ FEFaceValues::FEFaceValues (const Mapping &map template FEFaceValues::FEFaceValues (const FiniteElement &fe, - const Quadrature &quadrature, - const UpdateFlags update_flags) + const Quadrature &quadrature, + const UpdateFlags update_flags) : FEFaceValuesBase (quadrature.size(), - fe.dofs_per_cell, - update_flags, - StaticMappingQ1::mapping, - fe, quadrature) + fe.dofs_per_cell, + update_flags, + StaticMappingQ1::mapping, + fe, quadrature) { Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping")); initialize (update_flags); @@ -3665,7 +3665,7 @@ FEFaceValues::initialize (const UpdateFlags update_flags) template void FEFaceValues::reinit (const typename DoFHandler::cell_iterator &cell, - const unsigned int face_no) + const unsigned int face_no) { // assert that the finite elements // passed to the constructor and @@ -3699,7 +3699,7 @@ void FEFaceValues::reinit (const typename DoFHandler template void FEFaceValues::reinit (const typename hp::DoFHandler::cell_iterator &cell, - const unsigned int face_no) + const unsigned int face_no) { // assert that the finite elements // passed to the constructor and @@ -3756,7 +3756,7 @@ void FEFaceValues<2,3>::reinit (const MGDoFHandler<2,3>::cell_iterator &, template void FEFaceValues::reinit (const typename MGDoFHandler::cell_iterator &cell, - const unsigned int face_no) + const unsigned int face_no) { // assert that the finite elements // passed to the constructor and @@ -3790,7 +3790,7 @@ void FEFaceValues::reinit (const typename MGDoFHandler void FEFaceValues::reinit (const typename Triangulation::cell_iterator &cell, - const unsigned int face_no) + const unsigned int face_no) { Assert (face_no < GeometryInfo::faces_per_cell, ExcIndexRange (face_no, 0, GeometryInfo::faces_per_cell)); @@ -3855,15 +3855,15 @@ const unsigned int FESubfaceValues::integral_dimension; template FESubfaceValues::FESubfaceValues (const Mapping &mapping, - const FiniteElement &fe, - const Quadrature &quadrature, - const UpdateFlags update_flags) + const FiniteElement &fe, + const Quadrature &quadrature, + const UpdateFlags update_flags) : FEFaceValuesBase (quadrature.size(), - fe.dofs_per_cell, - update_flags, - mapping, - fe, quadrature) + fe.dofs_per_cell, + update_flags, + mapping, + fe, quadrature) { initialize (update_flags); } @@ -3872,14 +3872,14 @@ FESubfaceValues::FESubfaceValues (const Mapping template FESubfaceValues::FESubfaceValues (const FiniteElement &fe, - const Quadrature &quadrature, - const UpdateFlags update_flags) + const Quadrature &quadrature, + const UpdateFlags update_flags) : FEFaceValuesBase (quadrature.size(), - fe.dofs_per_cell, - update_flags, - StaticMappingQ1::mapping, - fe, quadrature) + fe.dofs_per_cell, + update_flags, + StaticMappingQ1::mapping, + fe, quadrature) { Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping")); initialize (update_flags); @@ -3910,8 +3910,8 @@ FESubfaceValues::initialize (const UpdateFlags update_flags) template void FESubfaceValues::reinit (const typename DoFHandler::cell_iterator &cell, - const unsigned int face_no, - const unsigned int subface_no) + const unsigned int face_no, + const unsigned int subface_no) { // assert that the finite elements // passed to the constructor and @@ -3963,8 +3963,8 @@ void FESubfaceValues::reinit (const typename DoFHandler void FESubfaceValues::reinit (const typename hp::DoFHandler::cell_iterator &cell, - const unsigned int face_no, - const unsigned int subface_no) + const unsigned int face_no, + const unsigned int subface_no) { // assert that the finite elements // passed to the constructor and @@ -4004,13 +4004,13 @@ void FESubfaceValues::reinit (const typename hp::DoFHandler void FESubfaceValues::reinit (const typename MGDoFHandler::cell_iterator &cell, - const unsigned int face_no, - const unsigned int subface_no) + const unsigned int face_no, + const unsigned int subface_no) { typedef FEValuesBase FEVB; Assert (static_cast&>(*this->fe) == - static_cast&>(cell->get_dof_handler().get_fe()), - typename FEVB::ExcFEDontMatch()); + static_cast&>(cell->get_dof_handler().get_fe()), + typename FEVB::ExcFEDontMatch()); Assert (face_no < GeometryInfo::faces_per_cell, ExcIndexRange (face_no, 0, GeometryInfo::faces_per_cell)); Assert (subface_no < cell->face(face_no)->number_of_children(), @@ -4041,8 +4041,8 @@ void FESubfaceValues::reinit (const typename MGDoFHandler void FESubfaceValues::reinit (const typename Triangulation::cell_iterator &cell, - const unsigned int face_no, - const unsigned int subface_no) + const unsigned int face_no, + const unsigned int subface_no) { Assert (face_no < GeometryInfo::faces_per_cell, ExcIndexRange (face_no, 0, GeometryInfo::faces_per_cell)); @@ -4170,9 +4170,9 @@ template class FEValuesData; template class FEValuesBase; template class FEValues; template class FEValuesBase:: - CellIterator::cell_iterator>; +CellIterator::cell_iterator>; template class FEValuesBase:: - CellIterator::cell_iterator>; +CellIterator::cell_iterator>; #if deal_II_dimension >= 2 template class FEFaceValuesBase; @@ -4185,7 +4185,7 @@ template class FEValuesData; template class FEValuesBase; template class FEValues; template class FEValuesBase:: - CellIterator::cell_iterator>; +CellIterator::cell_iterator>; //template class FEValuesBase:: // CellIterator::cell_iterator>;