From f349747d87ead4f501567419ce965dc8b5964549 Mon Sep 17 00:00:00 2001 From: wolf Date: Mon, 2 Dec 2002 20:23:21 +0000 Subject: [PATCH] Icc7 wants to see many more this-> pointers for its two-stage name lookup scheme. git-svn-id: https://svn.dealii.org/trunk@6799 0785d39b-7218-0410-832d-ea1e28bc413d --- .../base/source/auto_derivative_function.cc | 52 +++++++++--------- deal.II/deal.II/include/fe/fe_base.h | 8 +++ .../include/multigrid/mg_smoother.templates.h | 4 +- deal.II/deal.II/source/dofs/dof_accessor.cc | 4 +- deal.II/deal.II/source/fe/fe_dgp.cc | 6 +-- deal.II/deal.II/source/fe/fe_dgq.cc | 6 +-- deal.II/deal.II/source/fe/fe_nedelec.cc | 8 +-- deal.II/deal.II/source/fe/fe_q.cc | 6 +-- deal.II/deal.II/source/fe/fe_system.cc | 2 +- deal.II/deal.II/source/fe/mapping_q.cc | 54 +++++++++---------- .../deal.II/source/grid/grid_reordering.cc | 46 +++++++++------- .../source/multigrid/mg_dof_accessor.cc | 8 +-- .../deal.II/source/numerics/time_dependent.cc | 19 +++---- 13 files changed, 119 insertions(+), 104 deletions(-) diff --git a/deal.II/base/source/auto_derivative_function.cc b/deal.II/base/source/auto_derivative_function.cc index 25aec586a2..a143fc16ae 100644 --- a/deal.II/base/source/auto_derivative_function.cc +++ b/deal.II/base/source/auto_derivative_function.cc @@ -77,7 +77,7 @@ AutoDerivativeFunction::gradient (const Point &p, for (unsigned int i=0; ivalue(p, comp)-this->value(q1, comp))/h; } break; } @@ -88,7 +88,7 @@ AutoDerivativeFunction::gradient (const Point &p, { q1=p+ht[i]; q2=p-ht[i]; - grad[i]=(value(q1, comp)-value(q2, comp))/(2*h); + grad[i]=(this->value(q1, comp)-this->value(q2, comp))/(2*h); } break; } @@ -101,10 +101,10 @@ AutoDerivativeFunction::gradient (const Point &p, q1=q2+ht[i]; q3=p-ht[i]; q4=q3-ht[i]; - grad[i]=(- value(q1, comp) - +8*value(q2, comp) - -8*value(q3, comp) - + value(q4, comp))/(12*h); + grad[i]=(- this->value(q1, comp) + +8*this->value(q2, comp) + -8*this->value(q3, comp) + + this->value(q4, comp))/(12*h); } break; @@ -133,8 +133,8 @@ void AutoDerivativeFunction::vector_gradient (const Point &p, for (unsigned int i=0; ivector_value(p, v); + this->vector_value(q1, v1); for (unsigned int comp=0; compn_components; ++comp) gradients[comp][i]=(v(comp)-v1(comp))*h_inv; @@ -150,8 +150,8 @@ void AutoDerivativeFunction::vector_gradient (const Point &p, { q1=p+ht[i]; q2=p-ht[i]; - vector_value(q1, v1); - vector_value(q2, v2); + this->vector_value(q1, v1); + this->vector_value(q2, v2); for (unsigned int comp=0; compn_components; ++comp) gradients[comp][i]=(v1(comp)-v2(comp))*h_inv_2; @@ -171,10 +171,10 @@ void AutoDerivativeFunction::vector_gradient (const Point &p, q1=q2+ht[i]; q3=p-ht[i]; q4=q3-ht[i]; - vector_value(q1, v1); - vector_value(q2, v2); - vector_value(q3, v3); - vector_value(q4, v4); + this->vector_value(q1, v1); + this->vector_value(q2, v2); + this->vector_value(q3, v3); + this->vector_value(q4, v4); for (unsigned int comp=0; compn_components; ++comp) gradients[comp][i]=(-v1(comp)+8*v2(comp)-8*v3(comp)+v4(comp))*h_inv_12; @@ -204,7 +204,7 @@ void AutoDerivativeFunction::gradient_list (const std::vector > for (unsigned int i=0; ivalue(points[p], comp)-this->value(q1, comp))/h; } break; } @@ -216,7 +216,7 @@ void AutoDerivativeFunction::gradient_list (const std::vector > { q1=points[p]+ht[i]; q2=points[p]-ht[i]; - gradients[p][i]=(value(q1, comp)-value(q2, comp))/(2*h); + gradients[p][i]=(this->value(q1, comp)-this->value(q2, comp))/(2*h); } break; } @@ -230,10 +230,10 @@ void AutoDerivativeFunction::gradient_list (const std::vector > q1=q2+ht[i]; q3=points[p]-ht[i]; q4=q3-ht[i]; - gradients[p][i]=(- value(q1, comp) - +8*value(q2, comp) - -8*value(q3, comp) - + value(q4, comp))/(12*h); + gradients[p][i]=(- this->value(q1, comp) + +8*this->value(q2, comp) + -8*this->value(q3, comp) + + this->value(q4, comp))/(12*h); } break; } @@ -266,7 +266,7 @@ vector_gradient_list (const std::vector > &points, { q1=points[p]-ht[i]; for (unsigned int comp=0; compn_components; ++comp) - gradients[p][comp][i]=(value(points[p], comp)-value(q1, comp))/h; + gradients[p][comp][i]=(this->value(points[p], comp)-this->value(q1, comp))/h; } break; } @@ -279,7 +279,7 @@ vector_gradient_list (const std::vector > &points, q1=points[p]+ht[i]; q2=points[p]-ht[i]; for (unsigned int comp=0; compn_components; ++comp) - gradients[p][comp][i]=(value(q1, comp)-value(q2, comp))/(2*h); + gradients[p][comp][i]=(this->value(q1, comp)-this->value(q2, comp))/(2*h); } break; } @@ -294,10 +294,10 @@ vector_gradient_list (const std::vector > &points, q3=points[p]-ht[i]; q4=q3-ht[i]; for (unsigned int comp=0; compn_components; ++comp) - gradients[p][comp][i]=(- value(q1, comp) - +8*value(q2, comp) - -8*value(q3, comp) - + value(q4, comp))/(12*h); + gradients[p][comp][i]=(- this->value(q1, comp) + +8*this->value(q2, comp) + -8*this->value(q3, comp) + + this->value(q4, comp))/(12*h); } break; } diff --git a/deal.II/deal.II/include/fe/fe_base.h b/deal.II/deal.II/include/fe/fe_base.h index 6d5f4db352..9e75f5d666 100644 --- a/deal.II/deal.II/include/fe/fe_base.h +++ b/deal.II/deal.II/include/fe/fe_base.h @@ -1552,6 +1552,14 @@ class FiniteElementBase : public Subscriptor, * not already initialized. */ template friend class FESystem; + + /** + * Make the inner class a + * friend. This is not strictly + * necessary, but the Intel + * compiler seems to want this. + */ + friend class InternalDataBase; }; diff --git a/deal.II/deal.II/include/multigrid/mg_smoother.templates.h b/deal.II/deal.II/include/multigrid/mg_smoother.templates.h index bc6536aa17..81ebfd1a50 100644 --- a/deal.II/deal.II/include/multigrid/mg_smoother.templates.h +++ b/deal.II/deal.II/include/multigrid/mg_smoother.templates.h @@ -45,9 +45,9 @@ MGSmootherRelaxation for(unsigned i=0; iget_steps(); ++i) { (*matrix)[level].residual(h1, u, rhs); - set_zero_interior_boundary(level,h1); + this->set_zero_interior_boundary(level,h1); ((*matrix)[level].*relaxation)(h2,h1,omega); - set_zero_interior_boundary(level,h2); + this->set_zero_interior_boundary(level,h2); u.add(h2); } } diff --git a/deal.II/deal.II/source/dofs/dof_accessor.cc b/deal.II/deal.II/source/dofs/dof_accessor.cc index 5f0400da5d..b591d4e878 100644 --- a/deal.II/deal.II/source/dofs/dof_accessor.cc +++ b/deal.II/deal.II/source/dofs/dof_accessor.cc @@ -655,7 +655,7 @@ DoFCellAccessor::get_interpolated_dof_values (const InputVector &values, if (!this->has_children()) // if this cell has no children: simply // return the exact values on this cell - get_dof_values (values, interpolated_values); + this->get_dof_values (values, interpolated_values); else // otherwise clobber them from the children { @@ -759,7 +759,7 @@ DoFCellAccessor::set_dof_values_by_interpolation (const Vector &loc if (!this->has_children()) // if this cell has no children: simply // set the values on this cell - set_dof_values (local_values, values); + this->set_dof_values (local_values, values); else // otherwise distribute them to the children { diff --git a/deal.II/deal.II/source/fe/fe_dgp.cc b/deal.II/deal.II/source/fe/fe_dgp.cc index 71d8111e16..aec8650d6c 100644 --- a/deal.II/deal.II/source/fe/fe_dgp.cc +++ b/deal.II/deal.II/source/fe/fe_dgp.cc @@ -318,7 +318,7 @@ FE_DGP::fill_fe_values (const Mapping &mapping, } if (flags & update_second_derivatives) - compute_2nd (mapping, cell, 0, mapping_data, fe_data, data); + this->compute_2nd (mapping, cell, 0, mapping_data, fe_data, data); } @@ -365,7 +365,7 @@ FE_DGP::fill_fe_face_values (const Mapping &mapping, } if (flags & update_second_derivatives) - compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); + this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); } @@ -414,7 +414,7 @@ FE_DGP::fill_fe_subface_values (const Mapping &mappi } if (flags & update_second_derivatives) - compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); + this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); } diff --git a/deal.II/deal.II/source/fe/fe_dgq.cc b/deal.II/deal.II/source/fe/fe_dgq.cc index 08c8ae5027..485604393d 100644 --- a/deal.II/deal.II/source/fe/fe_dgq.cc +++ b/deal.II/deal.II/source/fe/fe_dgq.cc @@ -533,7 +533,7 @@ FE_DGQ::fill_fe_values (const Mapping &mapping, } if (flags & update_second_derivatives) - compute_2nd (mapping, cell, 0, mapping_data, fe_data, data); + this->compute_2nd (mapping, cell, 0, mapping_data, fe_data, data); } @@ -580,7 +580,7 @@ FE_DGQ::fill_fe_face_values (const Mapping &mapping, } if (flags & update_second_derivatives) - compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); + this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); } @@ -629,7 +629,7 @@ FE_DGQ::fill_fe_subface_values (const Mapping &mappi } if (flags & update_second_derivatives) - compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); + this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); } diff --git a/deal.II/deal.II/source/fe/fe_nedelec.cc b/deal.II/deal.II/source/fe/fe_nedelec.cc index 7d2e9e846b..14e7257f2c 100644 --- a/deal.II/deal.II/source/fe/fe_nedelec.cc +++ b/deal.II/deal.II/source/fe/fe_nedelec.cc @@ -937,7 +937,7 @@ FE_Nedelec::fill_fe_values (const Mapping &mapping, } if (flags & update_second_derivatives) - compute_2nd (mapping, cell, 0, mapping_data, fe_data, data); + this->compute_2nd (mapping, cell, 0, mapping_data, fe_data, data); }; @@ -988,7 +988,7 @@ FE_Nedelec::fill_fe_face_values (const Mapping &mapp std::vector > shape_values (n_q_points); - Assert (data.shape_values.n_rows() == dofs_per_cell * dim, + Assert (data.shape_values.n_rows() == this->dofs_per_cell * dim, ExcInternalError()); Assert (data.shape_values.n_cols() == n_q_points, ExcInternalError()); @@ -1078,7 +1078,7 @@ FE_Nedelec::fill_fe_face_values (const Mapping &mapp } if (flags & update_second_derivatives) - compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); + this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); } @@ -1221,7 +1221,7 @@ FE_Nedelec::fill_fe_subface_values (const Mapping &m } if (flags & update_second_derivatives) - compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); + this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); }; diff --git a/deal.II/deal.II/source/fe/fe_q.cc b/deal.II/deal.II/source/fe/fe_q.cc index 7a05b21fee..3a57551c16 100644 --- a/deal.II/deal.II/source/fe/fe_q.cc +++ b/deal.II/deal.II/source/fe/fe_q.cc @@ -1198,7 +1198,7 @@ FE_Q::fill_fe_values (const Mapping &mapping, } if (flags & update_second_derivatives) - compute_2nd (mapping, cell, 0, mapping_data, fe_data, data); + this->compute_2nd (mapping, cell, 0, mapping_data, fe_data, data); } @@ -1245,7 +1245,7 @@ FE_Q::fill_fe_face_values (const Mapping &mapping, } if (flags & update_second_derivatives) - compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); + this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); } @@ -1294,7 +1294,7 @@ FE_Q::fill_fe_subface_values (const Mapping &mapping } if (flags & update_second_derivatives) - compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); + this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); } diff --git a/deal.II/deal.II/source/fe/fe_system.cc b/deal.II/deal.II/source/fe/fe_system.cc index b2272e8340..29d5077385 100644 --- a/deal.II/deal.II/source/fe/fe_system.cc +++ b/deal.II/deal.II/source/fe/fe_system.cc @@ -860,7 +860,7 @@ compute_fill (const Mapping &mapping, ? face_no * n_q_points :(face_no * GeometryInfo::subfaces_per_face + sub_no) * n_q_points; - compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); + this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); } } diff --git a/deal.II/deal.II/source/fe/mapping_q.cc b/deal.II/deal.II/source/fe/mapping_q.cc index f90805632e..1318982481 100644 --- a/deal.II/deal.II/source/fe/mapping_q.cc +++ b/deal.II/deal.II/source/fe/mapping_q.cc @@ -210,11 +210,11 @@ MappingQ::get_data (const UpdateFlags update_flags, const Quadrature &quadrature) const { InternalData *data = new InternalData(n_shape_functions); - compute_data (update_flags, quadrature, - quadrature.n_quadrature_points, *data); + this->compute_data (update_flags, quadrature, + quadrature.n_quadrature_points, *data); if (!use_mapping_q_on_all_cells) - compute_data (update_flags, quadrature, - quadrature.n_quadrature_points, data->mapping_q1_data); + this->compute_data (update_flags, quadrature, + quadrature.n_quadrature_points, data->mapping_q1_data); return data; } @@ -227,12 +227,12 @@ MappingQ::get_face_data (const UpdateFlags update_flags, { InternalData *data = new InternalData(n_shape_functions); Quadrature q (QProjector::project_to_all_faces(quadrature)); - compute_face_data (update_flags, q, - quadrature.n_quadrature_points, *data); + this->compute_face_data (update_flags, q, + quadrature.n_quadrature_points, *data); if (!use_mapping_q_on_all_cells) - compute_face_data (update_flags, q, - quadrature.n_quadrature_points, - data->mapping_q1_data); + this->compute_face_data (update_flags, q, + quadrature.n_quadrature_points, + data->mapping_q1_data); return data; } @@ -245,12 +245,12 @@ MappingQ::get_subface_data (const UpdateFlags update_flags, { InternalData *data = new InternalData(n_shape_functions); Quadrature q (QProjector::project_to_all_subfaces(quadrature)); - compute_face_data (update_flags, q, - quadrature.n_quadrature_points, *data); + this->compute_face_data (update_flags, q, + quadrature.n_quadrature_points, *data); if (!use_mapping_q_on_all_cells) - compute_face_data (update_flags, q, - quadrature.n_quadrature_points, - data->mapping_q1_data); + this->compute_face_data (update_flags, q, + quadrature.n_quadrature_points, + data->mapping_q1_data); return data; } @@ -339,11 +339,11 @@ MappingQ::fill_fe_face_values (const typename DoFHandler::cell_iterato else p_data=&data; - compute_fill_face (cell, face_no, false, - npts, offset, q.get_weights(), - *p_data, - quadrature_points, JxW_values, - exterior_forms, normal_vectors); + this->compute_fill_face (cell, face_no, false, + npts, offset, q.get_weights(), + *p_data, + quadrature_points, JxW_values, + exterior_forms, normal_vectors); } @@ -395,11 +395,11 @@ MappingQ::fill_fe_subface_values (const typename DoFHandler::cell_iter else p_data=&data; - compute_fill_face (cell, face_no, true, - npts, offset, q.get_weights(), - *p_data, - quadrature_points, JxW_values, - exterior_forms, normal_vectors); + this->compute_fill_face (cell, face_no, true, + npts, offset, q.get_weights(), + *p_data, + quadrature_points, JxW_values, + exterior_forms, normal_vectors); } @@ -570,7 +570,7 @@ MappingQ::compute_laplace_vector(Table<2,double> &lvs) const InternalData quadrature_data(n_shape_functions); quadrature_data.shape_derivatives.resize(n_shape_functions * n_q_points); - compute_shapes(quadrature.get_points(), quadrature_data); + this->compute_shapes(quadrature.get_points(), quadrature_data); // Compute the stiffness matrix of // the inner dofs @@ -1210,7 +1210,7 @@ Point MappingQ::transform_unit_to_real_cell ( compute_mapping_support_points(cell, p_data->mapping_support_points); - const Point q=transform_unit_to_real_cell_internal(*p_data); + const Point q=this->transform_unit_to_real_cell_internal(*p_data); delete mdata; return q; } @@ -1240,7 +1240,7 @@ Point MappingQ::transform_real_to_unit_cell ( std::vector > &points=mdata->mapping_support_points; compute_mapping_support_points(cell, points); - transform_real_to_unit_cell_internal(cell, p, *mdata, p_unit); + this->transform_real_to_unit_cell_internal(cell, p, *mdata, p_unit); delete mdata; } diff --git a/deal.II/deal.II/source/grid/grid_reordering.cc b/deal.II/deal.II/source/grid/grid_reordering.cc index 125ad70f67..4eefed489b 100644 --- a/deal.II/deal.II/source/grid/grid_reordering.cc +++ b/deal.II/deal.II/source/grid/grid_reordering.cc @@ -114,10 +114,10 @@ GridReordering<2>::Cell::insert_faces (std::map &global_faces) // defined by the order of vertices // in the cell object Face new_faces[GeometryInfo::faces_per_cell] - = { { { vertices[0], vertices[1] } }, - { { vertices[1], vertices[2] } }, - { { vertices[3], vertices[2] } }, - { { vertices[0], vertices[3] } } }; + = { { { this->vertices[0], this->vertices[1] } }, + { { this->vertices[1], this->vertices[2] } }, + { { this->vertices[3], this->vertices[2] } }, + { { this->vertices[0], this->vertices[3] } } }; // then insert them into the global // list and store iterators to @@ -239,25 +239,31 @@ GridReordering<3>::Cell::insert_faces (std::map &global_faces) // reversed here compared to the // Cell class, for simplicity const Face new_faces_tmp[GeometryInfo::faces_per_cell] - = { { { vertices[0], vertices[1], vertices[2], vertices[3] } }, - { { vertices[4], vertices[5], vertices[6], vertices[7] } }, - { { vertices[0], vertices[1], vertices[5], vertices[4] } }, - { { vertices[1], vertices[5], vertices[6], vertices[2] } }, - { { vertices[3], vertices[2], vertices[6], vertices[7] } }, - { { vertices[0], vertices[4], vertices[7], vertices[3] } } }; + = { { { this->vertices[0], this->vertices[1], + this->vertices[2], this->vertices[3] } }, + { { this->vertices[4], this->vertices[5], + this->vertices[6], this->vertices[7] } }, + { { this->vertices[0], this->vertices[1], + this->vertices[5], this->vertices[4] } }, + { { this->vertices[1], this->vertices[5], + this->vertices[6], this->vertices[2] } }, + { { this->vertices[3], this->vertices[2], + this->vertices[6], this->vertices[7] } }, + { { this->vertices[0], this->vertices[4], + this->vertices[7], this->vertices[3] } } }; Face new_faces[GeometryInfo::faces_per_cell][GridReorderingInfo::rotational_states_of_faces] = { { new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], - new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] }, - { new_faces_tmp[1], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], + new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] }, + { new_faces_tmp[1], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] }, { new_faces_tmp[2], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], - new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] }, - { new_faces_tmp[3], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], - new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] }, - { new_faces_tmp[4], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], - new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] }, - { new_faces_tmp[5], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], - new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] }}; + new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] }, + { new_faces_tmp[3], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], + new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] }, + { new_faces_tmp[4], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], + new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] }, + { new_faces_tmp[5], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], + new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0], new_faces_tmp[0] }}; // first do the faces in their // usual direction @@ -446,7 +452,7 @@ GridReordering<3>::Cell::insert_faces (std::map &global_faces) // cell we are working on CellData standard_cell; for (unsigned int v=0; v::vertices_per_cell; ++v) - standard_cell.vertices[v] = vertices[v]; + standard_cell.vertices[v] = this->vertices[v]; // then rotate it the given // number of times diff --git a/deal.II/deal.II/source/multigrid/mg_dof_accessor.cc b/deal.II/deal.II/source/multigrid/mg_dof_accessor.cc index e68364210f..7c18a9f7c3 100644 --- a/deal.II/deal.II/source/multigrid/mg_dof_accessor.cc +++ b/deal.II/deal.II/source/multigrid/mg_dof_accessor.cc @@ -184,7 +184,7 @@ void MGDoFObjectAccessor<1, dim>::copy_from (const MGDoFObjectAccessor<1, dim> &a) { DoFObjectAccessor<1, dim>::copy_from (a); - set_mg_dof_handler (a.mg_dof_handler); + this->set_mg_dof_handler (a.mg_dof_handler); }; @@ -366,7 +366,7 @@ void MGDoFObjectAccessor<2, dim>::copy_from (const MGDoFObjectAccessor<2, dim> &a) { DoFObjectAccessor<2, dim>::copy_from (a); - set_mg_dof_handler (a.mg_dof_handler); + this->set_mg_dof_handler (a.mg_dof_handler); }; @@ -569,7 +569,7 @@ template void MGDoFObjectAccessor<3, dim>::copy_from (const MGDoFObjectAccessor<3, dim> &a) { DoFObjectAccessor<3, dim>::copy_from (a); - set_mg_dof_handler (a.mg_dof_handler); + this->set_mg_dof_handler (a.mg_dof_handler); }; @@ -638,7 +638,7 @@ template <> MGDoFCellAccessor<3>::face_iterator MGDoFCellAccessor<3>::face (const unsigned int i) const { - return quad(i); + return this->quad(i); }; #endif diff --git a/deal.II/deal.II/source/numerics/time_dependent.cc b/deal.II/deal.II/source/numerics/time_dependent.cc index e5279e9eac..30b64923f0 100644 --- a/deal.II/deal.II/source/numerics/time_dependent.cc +++ b/deal.II/deal.II/source/numerics/time_dependent.cc @@ -580,15 +580,15 @@ mirror_refinement_flags (const typename Triangulation::cell_iterator &new_c if (old_cell->has_children() && new_cell->has_children()) for (unsigned int c=0; c::children_per_cell; ++c) - mirror_refinement_flags (new_cell->child(c), old_cell->child(c)); + ::mirror_refinement_flags (new_cell->child(c), old_cell->child(c)); }; template static bool -adapt_grids (const typename Triangulation::cell_iterator &cell1, - const typename Triangulation::cell_iterator &cell2) +adapt_grid_cells (const typename Triangulation::cell_iterator &cell1, + const typename Triangulation::cell_iterator &cell2) { if (cell2->has_children() && cell1->has_children()) @@ -596,7 +596,8 @@ adapt_grids (const typename Triangulation::cell_iterator &cell1, bool grids_changed = false; for (unsigned int c=0; c::children_per_cell; ++c) - grids_changed |= adapt_grids (cell1->child(c), cell2->child(c)); + grids_changed |= ::adapt_grid_cells (cell1->child(c), + cell2->child(c)); return grids_changed; }; @@ -703,7 +704,7 @@ adapt_grids (Triangulation &tria1, typename Triangulation::cell_iterator(tria1.end()) : tria1.begin(1)); for (; cell1!=endc; ++cell1, ++cell2) - grids_changed |= adapt_grids (cell1, cell2); + grids_changed |= ::adapt_grid_cells (cell1, cell2); return grids_changed; }; @@ -826,7 +827,7 @@ void TimeStepBase_Tria::refine_grid (const RefinementData refinement_data) // (there are more coming below then // also) if (refinement_flags.adapt_grids) - adapt_grids (*previous_tria, *tria); + ::adapt_grids (*previous_tria, *tria); // perform flagging of cells // needed to regularize the @@ -1083,14 +1084,14 @@ void TimeStepBase_Tria::refine_grid (const RefinementData refinement_data) // strange things may happen if (refinement_flags.mirror_flags_to_previous_grid) { - adapt_grids (*previous_tria, *tria); + ::adapt_grids (*previous_tria, *tria); typename Triangulation::cell_iterator old_cell, new_cell, endc; old_cell = previous_tria->begin(0); new_cell = tria->begin(0); endc = tria->end(0); for (; new_cell!=endc; ++new_cell, ++old_cell) - mirror_refinement_flags (new_cell, old_cell); + ::mirror_refinement_flags (new_cell, old_cell); }; tria->prepare_coarsening_and_refinement (); @@ -1101,7 +1102,7 @@ void TimeStepBase_Tria::refine_grid (const RefinementData refinement_data) // cells to avoid the previous grid // to have cells refined twice more // than the present one and vica versa. - adapt_grids (*previous_tria, *tria); + ::adapt_grids (*previous_tria, *tria); }; }; -- 2.39.5