]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
TODOs fixed
authorguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 11 Sep 2001 14:04:38 +0000 (14:04 +0000)
committerguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 11 Sep 2001 14:04:38 +0000 (14:04 +0000)
git-svn-id: https://svn.dealii.org/trunk@4962 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/include/fe/fe_dgq.h
deal.II/deal.II/include/fe/fe_values.h
deal.II/deal.II/include/numerics/matrices.h
deal.II/deal.II/source/fe/fe_dgq.cc
deal.II/deal.II/source/fe/fe_values.cc
deal.II/deal.II/source/fe/mapping_cartesian.cc
deal.II/deal.II/source/fe/mapping_q1.cc
deal.II/deal.II/source/numerics/matrices.cc

index d58e24890d872fb35f0ef4b0b6668285b6faa9b9..7f22635c3f14d297ee25ca30e15b80080d9c9896 100644 (file)
@@ -238,6 +238,14 @@ class FE_DGQ : public FiniteElement<dim>
                                      * Compute renumbering for rotation
                                      * of degrees of freedom.
                                      *
+                                     * Rotates a tensor product
+                                     * numbering of degrees of
+                                     * freedom by 90 degrees. It is
+                                     * used to compute the transfer
+                                     * matrices of the children by
+                                     * using only the matrix for the
+                                     * first child.
+                                     *
                                      * The direction parameter
                                      * determines the type of
                                      * rotation. It is one character
@@ -247,9 +255,13 @@ class FE_DGQ : public FiniteElement<dim>
                                      * direction. Lower case is
                                      * counter-clockwise seen in
                                      * direction of the axis.
+                                     *
+                                     * Since rotation around the
+                                     * y-axis is not used, it is not
+                                     * implemented either.
                                      */
     void rotate_indices (std::vector<unsigned int> &indices,
-                        const char                 direction = 'y') const;
+                        const char                 direction) const;
   
                                     /**
                                      * Degree of the polynomials.
index 56102a5eb0e1b23ac62a578ea36e458eb87f6ece..8f48a330b7d178bc0e211be25967344a6541eb49 100644 (file)
@@ -247,7 +247,6 @@ class FEValuesBase : protected FEValuesData<dim>
 //TODO:[GK] What is the meaning of the n_values_array? It is not used in the implementation    
     FEValuesBase (const unsigned int n_q_points,
                  const unsigned int dofs_per_cell,
-                 const unsigned int n_values_array,
                  const UpdateFlags         update_flags,
                  const Mapping<dim>       &mapping,
                  const FiniteElement<dim> &fe);
@@ -752,7 +751,6 @@ class FEFaceValuesBase : public FEValuesBase<dim>
                                      */
     FEFaceValuesBase (const unsigned int n_q_points,
                      const unsigned int dofs_per_cell,
-                     const unsigned int n_faces_or_subfaces,
                      const UpdateFlags         update_flags,
                      const Mapping<dim>       &mapping,
                      const FiniteElement<dim> &fe,
index 91435db479189e0550a332852a16834bf9e40faf..a1c942b18adf5e6eff3c84d13188a2b92b339637 100644 (file)
@@ -343,20 +343,6 @@ class MatrixCreator
                                       SparseMatrix<double>     &matrix,
                                       const Function<dim> * const a = 0);
 
-                                    /**
-                                     * Generate Laplace matrix for a
-                                     * given level.
-                                     * 
-                                     * See the general doc of this
-                                     * class for more information.
-                                     */
-    template <int dim>
-    static void create_level_laplace_matrix (unsigned int             level,
-                                            const MGDoFHandler<dim>& dof,
-                                            const Quadrature<dim>&   q,
-                                            SparseMatrix<float>&     matrix,
-                                            const Function<dim>*     a = 0);
-
                                     /**
                                      * Assemble the Laplace matrix
                                      * and a right hand side
index 6bcbee64053f7ea31412e5722366b22aee716a02..6574b23e89cbb0b02252102baf8cae20b6277ab5 100644 (file)
@@ -351,7 +351,7 @@ FE_DGQ<dim>::rotate_indices (std::vector<unsigned int> &numbers,
                                                 // Rotate yz-plane
                                                 // clockwise
          case 'X':
-               Assert (dim>2, 
+               Assert (dim>2, 
                        typename FiniteElementData<dim>::ExcSpaceDimensionMismatch (dim,3));
                for (unsigned int iz=0;iz<n;++iz)
                  for (unsigned int iy=0;iy<n;++iy)
@@ -362,8 +362,7 @@ FE_DGQ<dim>::rotate_indices (std::vector<unsigned int> &numbers,
                      }
                break;
          default:
-//TODO:[GK] direction='y' is default, but is not implemented?!         
-               Assert (false, ExcNotImplemented ());
+           Assert (false, ExcNotImplemented ());
        }
     }
 }
index 2a199b945a02fa3eaeba33983d72ad4e2d6f85fc..bb9be8f047d07ff54bc86e938e1dcd1aa034e462 100644 (file)
@@ -77,7 +77,6 @@ FEValuesData<dim>::initialize (const unsigned int n_quadrature_points,
 template <int dim>
 FEValuesBase<dim>::FEValuesBase (const unsigned int n_q_points,
                                 const unsigned int dofs_per_cell,
-                                const unsigned int,
                                 const UpdateFlags flags,
                                 const Mapping<dim>       &mapping,
                                 const FiniteElement<dim> &fe)
@@ -490,7 +489,6 @@ FEValues<dim>::FEValues (const Mapping<dim>       &mapping,
                :
                FEValuesBase<dim> (q.n_quadrature_points,
                                   fe.dofs_per_cell,
-                                  1,
                                   update_default,
                                   mapping,
                                   fe),
@@ -508,7 +506,6 @@ FEValues<dim>::FEValues (const FiniteElement<dim> &fe,
                :
                FEValuesBase<dim> (q.n_quadrature_points,
                                   fe.dofs_per_cell,
-                                  1,
                                   update_default,
                                   get_default_mapping(),
                                   fe),
@@ -590,7 +587,6 @@ FEValues<dim>::memory_consumption () const
 template <int dim>
 FEFaceValuesBase<dim>::FEFaceValuesBase (const unsigned int n_q_points,
                                         const unsigned int dofs_per_cell,
-                                        const unsigned int n_faces_or_subfaces,
                                         const UpdateFlags,
                                         const Mapping<dim> &mapping,      
                                         const FiniteElement<dim> &fe,
@@ -598,7 +594,6 @@ FEFaceValuesBase<dim>::FEFaceValuesBase (const unsigned int n_q_points,
                :
                FEValuesBase<dim> (n_q_points,
                                   dofs_per_cell,
-                                  n_faces_or_subfaces,
                                   update_default,
                                   mapping,
                                   fe),
@@ -650,7 +645,6 @@ FEFaceValues<dim>::FEFaceValues (const Mapping<dim>       &mapping,
                :
                FEFaceValuesBase<dim> (quadrature.n_quadrature_points,
                                       fe.dofs_per_cell,
-                                      GeometryInfo<dim>::faces_per_cell,
                                       update_flags,
                                       mapping,
                                       fe, quadrature)
@@ -667,7 +661,6 @@ FEFaceValues<dim>::FEFaceValues (const FiniteElement<dim> &fe,
                :
                FEFaceValuesBase<dim> (quadrature.n_quadrature_points,
                                       fe.dofs_per_cell,
-                                      GeometryInfo<dim>::faces_per_cell,
                                       update_flags,
                                       get_default_mapping(),
                                       fe, quadrature)
@@ -742,8 +735,6 @@ FESubfaceValues<dim>::FESubfaceValues (const Mapping<dim>       &mapping,
                :
                FEFaceValuesBase<dim> (quadrature.n_quadrature_points,
                                       fe.dofs_per_cell,
-                                      GeometryInfo<dim>::faces_per_cell *
-                                      GeometryInfo<dim>::subfaces_per_face,
                                       update_flags,
                                       mapping,
                                       fe, quadrature)
@@ -760,8 +751,6 @@ FESubfaceValues<dim>::FESubfaceValues (const FiniteElement<dim> &fe,
                :
                FEFaceValuesBase<dim> (quadrature.n_quadrature_points,
                                       fe.dofs_per_cell,
-                                      GeometryInfo<dim>::faces_per_cell *
-                                      GeometryInfo<dim>::subfaces_per_face,
                                       update_flags,
                                       get_default_mapping(),
                                       fe, quadrature)
index 45de9489d5d6749ab89fffe24462a6498ec705b9..ba4c63635cf9ce41b7ccf7e90b165ccf0231ddeb 100644 (file)
@@ -299,7 +299,6 @@ MappingCartesian<dim>::fill_fe_values (const typename DoFHandler<dim>::cell_iter
                                   // equal and are the product of the
                                   // local lengths in each coordinate
                                   // direction
-//TODO:[GK] does it make sense to query the update flags in data if we did not set any in the get_*_data functions?
   if (data.current_update_flags() & update_JxW_values)
     {
       double J = data.length[0];
@@ -343,14 +342,12 @@ MappingCartesian<dim>::fill_fe_face_values (const typename DoFHandler<dim>::cell
     if (d != (normal_directions[face_no]/2))
       J *= data.length[d];
   
-//TODO:[GK] does it make sense to query the update flags in data if we did not set any in the get_*_data functions?
   if (data.current_update_flags() & update_JxW_values)
     {
       for (unsigned int i=0; i<JxW_values.size();++i)
        JxW_values[i] = J * q.weight(i);
     }
 
-//TODO:[GK] does it make sense to query the update flags in data if we did not set any in the get_*_data functions?
   if (data.current_update_flags() & update_boundary_forms)
     {
       for (unsigned int i=0; i<boundary_forms.size();++i)
@@ -391,14 +388,12 @@ MappingCartesian<dim>::fill_fe_subface_values (const typename DoFHandler<dim>::c
     if (d != (normal_directions[face_no]/2))
       J *= data.length[d];
   
-//TODO:[GK] does it make sense to query the update flags in data if we did not set any in the get_*_data functions?
   if (data.current_update_flags() & update_JxW_values)
     {
       for (unsigned int i=0; i<JxW_values.size();++i)
        JxW_values[i] = J * q.weight(i) / GeometryInfo<dim>::subfaces_per_face;
     }
 
-//TODO:[GK] does it make sense to query the update flags in data if we did not set any in the get_*_data functions?
   if (data.current_update_flags() & update_boundary_forms)
     {
       for (unsigned int i=0; i<boundary_forms.size();++i)
index 50837448919bbc261823064dec44e8d5274a13e5..61785bd559df296e8d588077f6d2792f976c2067 100644 (file)
@@ -607,7 +607,6 @@ MappingQ1<dim>::fill_fe_values (const typename DoFHandler<dim>::cell_iterator &c
 
                                   // Multiply quadrature weights
                                   // by Jacobian determinants
-//TODO:[?] compute Jacobi determinants directly, if co/contravariant is not needed
   if (update_flags & update_JxW_values)
     {      
       Assert (JxW_values.size() == npts,
index 245d16507bddd831d439408054efb7986d72a982..adf4e2b5930fb01c6e3d35951b48fdd78bde9fb4 100644 (file)
@@ -974,42 +974,6 @@ void MatrixCreator::create_laplace_matrix (const DoFHandler<dim>    &dof,
 }
 
 
-//TODO:[GK,RH] maybe recreate this function
-/*
-
-  template <int dim>
-  void MatrixCreator::create_level_laplace_matrix (unsigned int level,
-  const MGDoFHandler<dim>    &dof,
-  const Quadrature<dim>    &q,
-  SparseMatrix<float>     &matrix,
-  const Function<dim> * const a)
-  {
-  Vector<double> dummy;   // no entries, should give an error if accessed
-  UpdateFlags update_flags = UpdateFlags(update_gradients |
-  update_JxW_values);
-  if (a != 0)
-  update_flags = UpdateFlags(update_flags | update_q_points);
-  const Assembler<dim>::AssemblerData data (dof,
-  true, false,  // assemble matrix but not rhs
-  matrix, dummy,
-  q, update_flags);
-  TriaIterator<dim, Assembler<dim> >
-  assembler (const_cast<Triangulation<dim>*>(&dof.get_tria()),
-  dof.get_tria().begin(level)->level(),
-  dof.get_tria().begin(level)->index(),
-  &data);
-  LaplaceMatrix<dim> equation (0, a);
-  do 
-  {
-  assembler->assemble (equation);
-  ++assembler
-  }
-  while ( (assembler.state()==valid) && (assembler->level() == level) );
-  };
-
-*/
-
-
 
 template <int dim>
 void MatrixCreator::create_laplace_matrix (const Mapping<dim>       &mapping,

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.