]> https://gitweb.dealii.org/ - dealii.git/commitdiff
rename functions IntegrationInfo::fe to fe_values
authorGuido Kanschat <dr.guido.kanschat@gmail.com>
Fri, 5 Feb 2010 17:12:09 +0000 (17:12 +0000)
committerGuido Kanschat <dr.guido.kanschat@gmail.com>
Fri, 5 Feb 2010 17:12:09 +0000 (17:12 +0000)
git-svn-id: https://svn.dealii.org/trunk@20512 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/include/numerics/mesh_worker_info.h
deal.II/deal.II/include/numerics/mesh_worker_info.templates.h
deal.II/examples/step-38/step-38.cc
deal.II/examples/step-39/step-39.cc

index 36fedf501c3871254127ecd4fdf6118bd1e72827..f5944e2d34e554ec90bd8862d2d66017f467031b 100644 (file)
@@ -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 <int dim, class FVB, int spacedim>
   inline const FVB&
-  IntegrationInfo<dim,FVB,spacedim>::fe() const
+  IntegrationInfo<dim,FVB,spacedim>::fe_values() const
   {
     AssertDimension(fevalv.size(), 1);
     return *fevalv[0];
@@ -768,7 +768,7 @@ namespace MeshWorker
 
   template <int dim, class FVB, int spacedim>
   inline const FVB&
-  IntegrationInfo<dim,FVB,spacedim>::fe(unsigned int i) const
+  IntegrationInfo<dim,FVB,spacedim>::fe_values(unsigned int i) const
   {
     Assert (i<fevalv.size(), ExcIndexRange(i,0,fevalv.size()));
     return *fevalv[i];
index 3e2da89c2159b2d68fbd41743cd2412a6a3b7978..32ab8bceff013bf0e1fda33919dd0d437d9d6d5c 100644 (file)
@@ -174,7 +174,7 @@ namespace MeshWorker
        for (unsigned int b=0;b<this->block_info->local().size();++b)
          {
            const unsigned int fe_no = this->block_info->base_element(b);
-           const FEValuesBase<dim>& fe = this->fe(fe_no);
+           const FEValuesBase<dim>& 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<dim>& fe = this->fe(0);
+        const FEValuesBase<dim>& 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());
index 2a97fa4cda5b8cddb227cf2109a8653a4d6506e6..ab3f260722b9d4dff7e3d52e7c239b131c458c8a 100644 (file)
@@ -421,7 +421,7 @@ void DGMethod<dim>::integrate_cell_term (CellInfo& info)
                                   // structures, thus the access here
                                   // looks more complicated than
                                   // might seem necessary.
-  const FEValuesBase<dim>& fe_v = info.fe();
+  const FEValuesBase<dim>& fe_v = info.fe_values();
   FullMatrix<double>& local_matrix = info.M1[0].matrix;
   const std::vector<double> &JxW = fe_v.get_JxW_values ();
 
@@ -460,7 +460,7 @@ void DGMethod<dim>::integrate_cell_term (CellInfo& info)
 template <int dim>
 void DGMethod<dim>::integrate_boundary_term (FaceInfo& info)
 {
-  const FEFaceValuesBase<dim>& fe_v = info.fe();
+  const FEFaceValuesBase<dim>& fe_v = info.fe_values();
   FullMatrix<double>& local_matrix = info.M1[0].matrix;
   Vector<double>& local_vector = info.R[0].block(0);
 
@@ -511,12 +511,12 @@ void DGMethod<dim>::integrate_face_term (FaceInfo& info1,
                                   // etc., we use the
                                   // FEFaceValuesBase object of the
                                   // first argument.
-  const FEFaceValuesBase<dim>& fe_v = info1.fe();
+  const FEFaceValuesBase<dim>& fe_v = info1.fe_values();
 
                                   // For additional shape functions,
                                   // we have to ask the neighbors
                                   // FEFaceValuesBase.
-  const FEFaceValuesBase<dim>& fe_v_neighbor = info2.fe();
+  const FEFaceValuesBase<dim>& fe_v_neighbor = info2.fe_values();
 
                                   // Then we get references to the
                                   // four local matrices. The letters
index 51fd293606ab6dee489b8a3a301ae29c62664cd2..c39e0a8b74bd1d0a75e58ed38d5582f2e20003fe 100644 (file)
@@ -114,7 +114,7 @@ class MatrixIntegrator : public Subscriptor
 template <int dim>
 void MatrixIntegrator<dim>::cell(typename MeshWorker::IntegrationWorker<dim>::CellInfo& info)
 {
-  const FEValuesBase<dim>& fe = info.fe();
+  const FEValuesBase<dim>& fe = info.fe_values();
   FullMatrix<double>& local_matrix = info.M1[0].matrix;
   
   for (unsigned int k=0; k<fe.n_quadrature_points; ++k)
@@ -129,7 +129,7 @@ void MatrixIntegrator<dim>::cell(typename MeshWorker::IntegrationWorker<dim>::Ce
 template <int dim>
 void MatrixIntegrator<dim>::bdry(typename MeshWorker::IntegrationWorker<dim>::FaceInfo& info)
 {
-  const FEFaceValuesBase<dim>& fe = info.fe();
+  const FEFaceValuesBase<dim>& fe = info.fe_values();
   FullMatrix<double>& local_matrix = info.M1[0].matrix;
   
   const unsigned int deg = fe.get_fe().tensor_degree();
@@ -149,8 +149,8 @@ template <int dim>
 void MatrixIntegrator<dim>::face(typename MeshWorker::IntegrationWorker<dim>::FaceInfo& info1,
                                 typename MeshWorker::IntegrationWorker<dim>::FaceInfo& info2)
 {
-  const FEFaceValuesBase<dim>& fe1 = info1.fe();
-  const FEFaceValuesBase<dim>& fe2 = info2.fe();
+  const FEFaceValuesBase<dim>& fe1 = info1.fe_values();
+  const FEFaceValuesBase<dim>& fe2 = info2.fe_values();
   FullMatrix<double>& matrix_v1u1 = info1.M1[0].matrix;
   FullMatrix<double>& matrix_v1u2 = info1.M2[0].matrix;
   FullMatrix<double>& matrix_v2u1 = info2.M2[0].matrix;
@@ -211,7 +211,7 @@ void RHSIntegrator<dim>::cell(typename MeshWorker::IntegrationWorker<dim>::CellI
 template <int dim>
 void RHSIntegrator<dim>::bdry(typename MeshWorker::IntegrationWorker<dim>::FaceInfo& info)
 {
-  const FEFaceValuesBase<dim>& fe = info.fe();
+  const FEFaceValuesBase<dim>& fe = info.fe_values();
   Vector<double>& local_vector = info.R[0].block(0);
   
   std::vector<double> boundary_values(fe.n_quadrature_points);
@@ -248,7 +248,7 @@ class Estimator : public Subscriptor
 template <int dim>
 void Estimator<dim>::cell(typename MeshWorker::IntegrationWorker<dim>::CellInfo& info)
 {
-  const FEValuesBase<dim>& fe = info.fe();
+  const FEValuesBase<dim>& fe = info.fe_values();
   
   const std::vector<Tensor<2,dim> >& DDuh = info.hessians[0][0];
   for (unsigned k=0;k<fe.n_quadrature_points;++k)
@@ -262,7 +262,7 @@ void Estimator<dim>::cell(typename MeshWorker::IntegrationWorker<dim>::CellInfo&
 template <int dim>
 void Estimator<dim>::bdry(typename MeshWorker::IntegrationWorker<dim>::FaceInfo& info)
 {
-  const FEFaceValuesBase<dim>& fe = info.fe();
+  const FEFaceValuesBase<dim>& fe = info.fe_values();
   
   std::vector<double> boundary_values(fe.n_quadrature_points);
   exact_solution.value_list(fe.get_quadrature_points(), boundary_values);
@@ -282,7 +282,7 @@ template <int dim>
 void Estimator<dim>::face(typename MeshWorker::IntegrationWorker<dim>::FaceInfo& info1,
                          typename MeshWorker::IntegrationWorker<dim>::FaceInfo& info2)
 {
-  const FEFaceValuesBase<dim>& fe = info1.fe();
+  const FEFaceValuesBase<dim>& fe = info1.fe_values();
   const std::vector<double>& uh1 = info1.values[0][0];
   const std::vector<double>& uh2 = info2.values[0][0];
   const std::vector<Tensor<1,dim> >& Duh1 = info1.gradients[0][0];

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.