From fea340c2ae021234daf0e3f99c5086d5c41c535b Mon Sep 17 00:00:00 2001 From: Luca Heltai Date: Fri, 15 May 2015 22:36:22 +0200 Subject: [PATCH] Fixed names and typedefs. --- include/deal.II/fe/mapping_fe_field.h | 16 ++------------- source/fe/mapping_fe_field.cc | 28 +++++++++++++-------------- 2 files changed, 16 insertions(+), 28 deletions(-) diff --git a/include/deal.II/fe/mapping_fe_field.h b/include/deal.II/fe/mapping_fe_field.h index e005466975..e1c5c45354 100644 --- a/include/deal.II/fe/mapping_fe_field.h +++ b/include/deal.II/fe/mapping_fe_field.h @@ -586,31 +586,19 @@ private: */ void update_internal_dofs(const typename Triangulation::cell_iterator &cell) const; - /** - * Typedef holding the local cell_dofs. - */ - typedef - Threads::ThreadLocalStorage > local_dofs_t; - - /** - * Typedef holding the local dof indices. - */ - typedef - Threads::ThreadLocalStorage > local_dof_indices_t; - /** * It stores the local degrees of freedom of the DH for each cell * (i.e. euler_vector * dof_indices, see method update_internal_dofs for more * clarifications.). */ - mutable local_dofs_t local_dofs; + mutable Threads::ThreadLocalStorage > local_dof_values; /** * Store the degrees of freedom of the DH for each cell (i.e. * cell->get_dof_indices(dof_indices), see method update_internal_dofs for more * clarifications.). Thread safe. */ - mutable local_dof_indices_t dof_indices; + mutable Threads::ThreadLocalStorage > local_dof_indices; /** Reimplemented from Mapping. See the documentation of the base class for * detailed information. diff --git a/source/fe/mapping_fe_field.cc b/source/fe/mapping_fe_field.cc index 2923c99057..b636a38ead 100644 --- a/source/fe/mapping_fe_field.cc +++ b/source/fe/mapping_fe_field.cc @@ -70,8 +70,8 @@ MappingFEField::MappingFEField (const DH &euler_dof euler_vector(&euler_vector), fe(&euler_dof_handler.get_fe()), euler_dof_handler(&euler_dof_handler), - local_dofs(std::vector(fe->dofs_per_cell)), - dof_indices(std::vector(fe->dofs_per_cell)), + local_dof_values(std::vector(fe->dofs_per_cell)), + local_dof_indices(std::vector(fe->dofs_per_cell)), fe_mask(mask.size() ? mask : ComponentMask(fe->get_nonzero_components(0).size(), true)), fe_to_real(fe_mask.size(), numbers::invalid_unsigned_int) @@ -92,8 +92,8 @@ MappingFEField::MappingFEField (const MappingFEField(fe->dofs_per_cell)), - dof_indices(std::vector(fe->dofs_per_cell)), + local_dof_values(std::vector(fe->dofs_per_cell)), + local_dof_indices(std::vector(fe->dofs_per_cell)), fe_mask(mapping.fe_mask), fe_to_real(mapping.fe_to_real) {} @@ -386,8 +386,8 @@ MappingFEField::fill_fe_values ( std::vector > &normal_vectors, CellSimilarity::Similarity &cell_similarity) const { - AssertDimension(fe->dofs_per_cell, local_dofs.get().size()); - Assert(local_dofs.get().size()>0, ExcMessage("Cannot do anything with zero degrees of freedom")); + AssertDimension(fe->dofs_per_cell, local_dof_values.get().size()); + Assert(local_dof_values.get().size()>0, ExcMessage("Cannot do anything with zero degrees of freedom")); // convert data object to internal data for this class. fails with an // exception if that is not possible @@ -520,7 +520,7 @@ MappingFEField::fill_fe_values ( for (unsigned int j=0; jsystem_to_component_index(i).first; if (fe_mask[comp_i]) - p_real[fe_to_real[comp_i]] += local_dofs.get()[i] * data.shape(0,i); + p_real[fe_to_real[comp_i]] += local_dof_values.get()[i] * data.shape(0,i); } return p_real; @@ -896,7 +896,7 @@ transform_real_to_unit_cell_internal unsigned int comp_k = fe->system_to_component_index(k).first; if (fe_mask[comp_k]) for (unsigned int j=0; j::compute_fill ( { unsigned int comp_k = fe->system_to_component_index(k).first; if (fe_mask[comp_k]) - result[fe_to_real[comp_k]] += local_dofs.get()[k] * shape[k]; + result[fe_to_real[comp_k]] += local_dof_values.get()[k] * shape[k]; } quadrature_points[point] = result; @@ -1024,7 +1024,7 @@ MappingFEField::compute_fill ( { unsigned int comp_k = fe->system_to_component_index(k).first; if (fe_mask[comp_k]) - result[fe_to_real[comp_k]] += local_dofs.get()[k] * data_derv[k]; + result[fe_to_real[comp_k]] += local_dof_values.get()[k] * data_derv[k]; } // write result into contravariant data. for @@ -1231,10 +1231,10 @@ MappingFEField::update_internal_dofs ( typename DH::cell_iterator dof_cell(*cell, euler_dof_handler); Assert (dof_cell->active() == true, ExcInactiveCell()); - dof_cell->get_dof_indices(dof_indices.get()); + dof_cell->get_dof_indices(local_dof_indices.get()); - for (unsigned int i=0; i