From: Guido Kanschat Date: Fri, 5 Feb 2010 17:12:09 +0000 (+0000) Subject: rename functions IntegrationInfo::fe to fe_values X-Git-Tag: v8.0.0~6535 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=9a256165f805f46d9a8b8b64aa363825b3426c7d;p=dealii.git rename functions IntegrationInfo::fe to fe_values git-svn-id: https://svn.dealii.org/trunk@20512 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/deal.II/include/numerics/mesh_worker_info.h b/deal.II/deal.II/include/numerics/mesh_worker_info.h index 36fedf501c..f5944e2d34 100644 --- a/deal.II/deal.II/include/numerics/mesh_worker_info.h +++ b/deal.II/deal.II/include/numerics/mesh_worker_info.h @@ -402,7 +402,7 @@ namespace MeshWorker * exception, if applied to a * vector of elements. */ - const FEVALUESBASE& fe() const; + const FEVALUESBASE& fe_values () const; /// Access to finite elements /** @@ -413,7 +413,7 @@ namespace MeshWorker * * @see DGBlockSplitApplication */ - const FEVALUESBASE& fe(const unsigned int i) const; + const FEVALUESBASE& fe_values (const unsigned int i) const; /** * The vector containing the @@ -759,7 +759,7 @@ namespace MeshWorker template inline const FVB& - IntegrationInfo::fe() const + IntegrationInfo::fe_values() const { AssertDimension(fevalv.size(), 1); return *fevalv[0]; @@ -768,7 +768,7 @@ namespace MeshWorker template inline const FVB& - IntegrationInfo::fe(unsigned int i) const + IntegrationInfo::fe_values(unsigned int i) const { Assert (iblock_info->local().size();++b) { const unsigned int fe_no = this->block_info->base_element(b); - const FEValuesBase& fe = this->fe(fe_no); + const FEValuesBase& fe = this->fe_values(fe_no); const unsigned int n_comp = fe.get_fe().n_components(); const unsigned int block_start = this->block_info->local().block_start(b); const unsigned int block_size = this->block_info->local().block_size(b); @@ -186,7 +186,7 @@ namespace MeshWorker } else { - const FEValuesBase& fe = this->fe(0); + const FEValuesBase& fe = this->fe_values(0); const unsigned int n_comp = fe.get_fe().n_components(); this->global_data->fill(values, gradients, hessians, fe, this->indices, 0, n_comp, 0, this->indices.size()); diff --git a/deal.II/examples/step-38/step-38.cc b/deal.II/examples/step-38/step-38.cc index 2a97fa4cda..ab3f260722 100644 --- a/deal.II/examples/step-38/step-38.cc +++ b/deal.II/examples/step-38/step-38.cc @@ -421,7 +421,7 @@ void DGMethod::integrate_cell_term (CellInfo& info) // structures, thus the access here // looks more complicated than // might seem necessary. - const FEValuesBase& fe_v = info.fe(); + const FEValuesBase& fe_v = info.fe_values(); FullMatrix& local_matrix = info.M1[0].matrix; const std::vector &JxW = fe_v.get_JxW_values (); @@ -460,7 +460,7 @@ void DGMethod::integrate_cell_term (CellInfo& info) template void DGMethod::integrate_boundary_term (FaceInfo& info) { - const FEFaceValuesBase& fe_v = info.fe(); + const FEFaceValuesBase& fe_v = info.fe_values(); FullMatrix& local_matrix = info.M1[0].matrix; Vector& local_vector = info.R[0].block(0); @@ -511,12 +511,12 @@ void DGMethod::integrate_face_term (FaceInfo& info1, // etc., we use the // FEFaceValuesBase object of the // first argument. - const FEFaceValuesBase& fe_v = info1.fe(); + const FEFaceValuesBase& fe_v = info1.fe_values(); // For additional shape functions, // we have to ask the neighbors // FEFaceValuesBase. - const FEFaceValuesBase& fe_v_neighbor = info2.fe(); + const FEFaceValuesBase& fe_v_neighbor = info2.fe_values(); // Then we get references to the // four local matrices. The letters diff --git a/deal.II/examples/step-39/step-39.cc b/deal.II/examples/step-39/step-39.cc index 51fd293606..c39e0a8b74 100644 --- a/deal.II/examples/step-39/step-39.cc +++ b/deal.II/examples/step-39/step-39.cc @@ -114,7 +114,7 @@ class MatrixIntegrator : public Subscriptor template void MatrixIntegrator::cell(typename MeshWorker::IntegrationWorker::CellInfo& info) { - const FEValuesBase& fe = info.fe(); + const FEValuesBase& fe = info.fe_values(); FullMatrix& local_matrix = info.M1[0].matrix; for (unsigned int k=0; k::cell(typename MeshWorker::IntegrationWorker::Ce template void MatrixIntegrator::bdry(typename MeshWorker::IntegrationWorker::FaceInfo& info) { - const FEFaceValuesBase& fe = info.fe(); + const FEFaceValuesBase& fe = info.fe_values(); FullMatrix& local_matrix = info.M1[0].matrix; const unsigned int deg = fe.get_fe().tensor_degree(); @@ -149,8 +149,8 @@ template void MatrixIntegrator::face(typename MeshWorker::IntegrationWorker::FaceInfo& info1, typename MeshWorker::IntegrationWorker::FaceInfo& info2) { - const FEFaceValuesBase& fe1 = info1.fe(); - const FEFaceValuesBase& fe2 = info2.fe(); + const FEFaceValuesBase& fe1 = info1.fe_values(); + const FEFaceValuesBase& fe2 = info2.fe_values(); FullMatrix& matrix_v1u1 = info1.M1[0].matrix; FullMatrix& matrix_v1u2 = info1.M2[0].matrix; FullMatrix& matrix_v2u1 = info2.M2[0].matrix; @@ -211,7 +211,7 @@ void RHSIntegrator::cell(typename MeshWorker::IntegrationWorker::CellI template void RHSIntegrator::bdry(typename MeshWorker::IntegrationWorker::FaceInfo& info) { - const FEFaceValuesBase& fe = info.fe(); + const FEFaceValuesBase& fe = info.fe_values(); Vector& local_vector = info.R[0].block(0); std::vector boundary_values(fe.n_quadrature_points); @@ -248,7 +248,7 @@ class Estimator : public Subscriptor template void Estimator::cell(typename MeshWorker::IntegrationWorker::CellInfo& info) { - const FEValuesBase& fe = info.fe(); + const FEValuesBase& fe = info.fe_values(); const std::vector >& DDuh = info.hessians[0][0]; for (unsigned k=0;k::cell(typename MeshWorker::IntegrationWorker::CellInfo& template void Estimator::bdry(typename MeshWorker::IntegrationWorker::FaceInfo& info) { - const FEFaceValuesBase& fe = info.fe(); + const FEFaceValuesBase& fe = info.fe_values(); std::vector boundary_values(fe.n_quadrature_points); exact_solution.value_list(fe.get_quadrature_points(), boundary_values); @@ -282,7 +282,7 @@ template void Estimator::face(typename MeshWorker::IntegrationWorker::FaceInfo& info1, typename MeshWorker::IntegrationWorker::FaceInfo& info2) { - const FEFaceValuesBase& fe = info1.fe(); + const FEFaceValuesBase& fe = info1.fe_values(); const std::vector& uh1 = info1.values[0][0]; const std::vector& uh2 = info2.values[0][0]; const std::vector >& Duh1 = info1.gradients[0][0];