]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Assign names to TODOs.
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 29 Mar 2001 14:59:33 +0000 (14:59 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 29 Mar 2001 14:59:33 +0000 (14:59 +0000)
git-svn-id: https://svn.dealii.org/trunk@4332 0785d39b-7218-0410-832d-ea1e28bc413d

31 files changed:
deal.II/deal.II/include/fe/fe_base.h
deal.II/deal.II/include/fe/fe_dgq.h
deal.II/deal.II/include/fe/fe_lib.dg.h
deal.II/deal.II/include/fe/fe_lib.lagrange.h
deal.II/deal.II/include/fe/fe_q.h
deal.II/deal.II/include/fe/fe_values.h
deal.II/deal.II/include/fe/mapping_q.h
deal.II/deal.II/include/multigrid/mg_dof_handler.h
deal.II/deal.II/include/multigrid/mg_dof_tools.h
deal.II/deal.II/include/multigrid/multigrid.h
deal.II/deal.II/include/multigrid/multigrid.templates.h
deal.II/deal.II/include/numerics/vectors.h
deal.II/deal.II/source/fe/fe_dgq.cc
deal.II/deal.II/source/fe/fe_q.cc
deal.II/deal.II/source/fe/fe_system.cc
deal.II/deal.II/source/fe/fe_tools.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_q.cc
deal.II/deal.II/source/fe/mapping_q1.cc
deal.II/deal.II/source/grid/grid_out.cc
deal.II/deal.II/source/multigrid/mg_dof_handler.cc
deal.II/deal.II/source/multigrid/multigrid.cc
deal.II/deal.II/source/numerics/data_out.cc
deal.II/deal.II/source/numerics/data_out_faces.cc
deal.II/deal.II/source/numerics/data_out_rotation.cc
deal.II/deal.II/source/numerics/data_out_stack.cc
deal.II/deal.II/source/numerics/derivative_approximation.cc
deal.II/deal.II/source/numerics/error_estimator.cc
deal.II/deal.II/source/numerics/matrices.cc
deal.II/deal.II/source/numerics/vectors.cc

index 23310a563270a6a9d130fb0333861442a7fd8e72..38249308b54bfdef144ca829452a53b96cfc5e79 100644 (file)
@@ -192,7 +192,7 @@ class FiniteElementData
 };
 
 
-//TODO: Unify FiniteElementBase with FiniteElement? There is no clear distinction between the two
+//TODO:[WB] Unify FiniteElementBase with FiniteElement? There is no clear distinction between the two
 
 /**
  * Base class for finite elements in arbitrary dimensions. This class
index dedbb0b76d26c30e15a07cac4f9a0e089385d8fb..e5b6266ff1d7d779036dda251418ad610fef3377 100644 (file)
@@ -22,7 +22,7 @@ template <int dim> class MappingQ;
 
 /**
  * Discontinuous tensor product elements based on equidistant support points.
-//TODO: Document node numbering etc. copy from old documentation 
+//TODO:[GK,RH] Document node numbering etc. copy from old documentation 
  */
 template <int dim>
 class FE_DGQ : public FiniteElement<dim>
@@ -196,7 +196,7 @@ class FE_DGQ : public FiniteElement<dim>
                                     /**
                                      * Compute renumbering for rotation
                                      * of degrees of freedom.
-//TODO: meaning of direction=[zZxXyY]                                
+//TODO:[GK] meaning of direction=[zZxXyY]                                    
                                      */
     void rotate_indices (std::vector<unsigned int> &indices,
                         const char                 direction = 'y') const;
@@ -254,7 +254,7 @@ class FE_DGQ : public FiniteElement<dim>
                                          * entries in lower dimensions
                                          * are missing.
                                          */
-//TODO: what good is this, the base class already has it and it seems never to be used!?
+//TODO:[GK] what good is this, the base class already has it and it seems never to be used!?
        std::vector<FEValues<dim>*> differences;
     };
     
index 0405db77ef863eef9396c6f9ce7ee18c4605777e..fcdb94dacd038d78292320d3162d787746492ad7 100644 (file)
@@ -17,7 +17,7 @@
 #include<fe/fe_dgq.h>
 
 
-//TODO: briefly document classes and mark them deprecated
+//TODO:[WB,RH] briefly document classes and mark them deprecated
 
 
 template<int dim> class FEDG_Q0: public FE_DGQ<dim>
index 52ab4aefedb04fb1447cc447472c3b051531e314..61129b3c33b34205d4f6dd7055c561996e1bc8bb 100644 (file)
@@ -17,7 +17,7 @@
 #include<fe/fe_q.h>
 
 
-//TODO: briefly document classes and mark them deprecated
+//TODO:[WB,RH] briefly document classes and mark them deprecated
 
 
 template<int dim> class FEQ1: public FE_Q<dim>
index 04206bf33a4fd901134709287f0b2cd6b7b8d79b..6c8e6f9aca499357b94dc678ea74b526349d4947 100644 (file)
@@ -23,7 +23,7 @@ template <int dim> class MappingQ;
 
 /**
  * Tensor product elements based on equidistant support points.
-//TODO: Document node numbering etc. copy from old documentation 
+//TODO:[RH,GK] Document node numbering etc. copy from old documentation 
  */
 template <int dim>
 class FE_Q : public FiniteElement<dim>
@@ -40,7 +40,7 @@ class FE_Q : public FiniteElement<dim>
                                      */
     ~FE_Q ();
 
-//TODO: make get_renumber private or move it some other place    
+//TODO:[RH] make get_renumber private or move it some other place    
                                     /**
                                      * Read-only access to the
                                      * renumber vector.
index b545207fce3ec7b125030719b0c9721ac8789d2a..554c26ec77fea5018fc474c9760332999baf3e41 100644 (file)
@@ -244,7 +244,7 @@ class FEValuesBase : protected FEValuesData<dim>
                                      * constructor of the derived
                                      * class.
                                      */
-//TODO: What is the meaning of the n_values_array? It is not used in the implementation    
+//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,
index d894a80537dbf9164e491cb77ace5d31a0bb913c..8e2d3c860284b76ca7bf7c743e0f4b81bc674204 100644 (file)
@@ -23,11 +23,11 @@ class LagrangeEquidistant;
 
 
 
-//TODO: (later) doc: laplace_on_quad_vector, compute_laplace_on_quad, etc all
+//TODO:[RH] (later) doc: laplace_on_quad_vector, compute_laplace_on_quad, etc all
 //      see upcoming paper.
 
 
-//TODO: more docs
+//TODO:[RH,GK] more docs
 /**
  * Mapping class that uses Qp-mappings on boundary cells. The mapping
  * shape functions make use of tensor product polynomials with
@@ -402,7 +402,7 @@ class MappingQ : public MappingQ1<dim>
                                      * Needed by the
                                      * @p{compute_support_points_simple}
                                      */
-//TODO: (later) remove this function altogether?    
+//TODO:[RH] (later) remove this function altogether?    
     void fill_quad_support_points_simple (const Triangulation<dim>::cell_iterator &cell,
                                          std::vector<Point<dim> > &a) const;
     
index 25215179eb50f16e820e0badf739918405300b61..9c1d0d37ae8c0ef4dd2b09a8486f227eb35d26f4 100644 (file)
@@ -137,7 +137,7 @@ class MGDoFDimensionInfo<3>
  *
  * At present, multilevel algorithms are not fully functional, so this
  * documentation is still very brief.
-//TODO: Extend MGDoFHandler doc 
+//TODO:[WB] Extend MGDoFHandler doc 
  *
  * @author Wolfgang Bangerth, 1998, 1999
  */
index baa8febe27a39dd78b0ccd00c559a766b25491c6..5747621f25af8099ad335e1faa71629c0974b816 100644 (file)
@@ -14,7 +14,7 @@
 #define __deal2__mg_dof_tools_h
 
 
-//TODO: Consider incorporating these functions in DoFTools
+//TODO:[?] Consider incorporating these functions in DoFTools (why?)
 
 /**
  * This is a collection of functions operating on, and manipulating
index 068e16106eea2adda889192dfe5492ec6df138f0..e5dc0ff3b9597e91a130c8a145264375e1eb7e66 100644 (file)
@@ -62,7 +62,7 @@ class Multigrid : public MGBase
                                      * therefore create objects of
                                      * this type as late as possible.
                                      */
-//TODO: minlevel, maxlevel?
+//TODO:[GK] meaning of minlevel, maxlevel?
     Multigrid(const MGDoFHandler<dim>                       &mg_dof_handler,
              const ConstraintMatrix                        &constraints,
              const MGLevelObject<SparsityPattern>       &level_sparsities,
@@ -97,9 +97,9 @@ class Multigrid : public MGBase
 
                                     /**
                                      * Negative @p{vmult} on a level.
-//TODO: what does this function do?                                  
-* @see MGBase.
-*/
+                                     * @see MGBase.
+                                     */
+//TODO:[GK] what does this function do?    
     virtual void level_vmult (const unsigned int    level,
                              Vector<double>       &dest,
                              const Vector<double> &src,
index 97d708547f4f57406df927974266a5dee4825c08..7385e2a39ae60a1978f6e4fe797ac737d5567974 100644 (file)
@@ -23,7 +23,7 @@
 #include <lac/sparse_matrix.h>
 
 
-//TODO: This function needs to be specially implemented, since in 2d mode we use faces
+//TODO:[?] This function needs to be specially implemented, since in 2d mode we use faces
 #if deal_II_dimension == 1
 
 template <int dim>
@@ -84,7 +84,7 @@ Multigrid<dim>::copy_to_mg (const Vector<number>& osrc)
       const MGDoFHandler<dim>::active_cell_iterator
        level_end  = mg_dof_handler->end_active(level);
 
-//TODO: Treat hanging nodes properly
+//TODO:[?] Treat hanging nodes properly
 // The single-level vector is not an FE-function, because the values at
 // hanging nodes are set to zero. This should be treated before the restriction.
 
index 8ccd50bcd37b0a1cac8fe9e8983dccd40f2d8ec9..cee7163710415be402ce6300587a6e170f1e83d9 100644 (file)
@@ -450,8 +450,8 @@ class VectorTools
                                             std::map<unsigned int,double> &boundary_values,
                                             const std::vector<bool>       &component_mask = std::vector<bool>());
 
-//TODO: Update project_boundary_values for more components
-//TODO: Replace FunctionMap
+//TODO:[WB] Update project_boundary_values for more components
+//TODO:[WB] Replace FunctionMap
                                     /**
                                      * Project @p{function} to the boundary
                                      * of the domain, using the given quadrature
@@ -573,7 +573,7 @@ class VectorTools
                                      * be computed and later
                                      * subtracted.
                                      */
-// TODO: Implementation of subtract_mean_value is missing.    
+//TODO:[GK] Implementation of subtract_mean_value is missing.    
     static void subtract_mean_value(Vector<double>          &v,
                                    const std::vector<bool> &p_select);
     
index baef3662148e2699ac694de99661cc5eedd3c484..62362176fa20ba769c019af7b83dc7e8f6ba832a 100644 (file)
@@ -345,7 +345,7 @@ FE_DGQ<dim>::rotate_indices (std::vector<unsigned int> &numbers,
                      }
                break;
          default:
-//TODO: direction='y' is default, but is not implemented?!             
+//TODO:[GK] direction='y' is default, but is not implemented?!         
                Assert (false, ExcNotImplemented ());
        }
     }
index 24a8ab12f8e78a82e8536ca147b41001a4deddd8..afd4c35ad4262bf7a019af4ead415bce2b06180c 100644 (file)
@@ -25,7 +25,7 @@
 
 
 
-//TODO: move build_renumbering to mapping class
+//TODO:[RH] move build_renumbering to mapping class
 
 template <int dim>
 FE_Q<dim>::FE_Q (const unsigned int degree)
@@ -49,7 +49,7 @@ FE_Q<dim>::FE_Q (const unsigned int degree)
 
                                   // do some internal book-keeping
   build_renumbering (*this, degree, renumber);
-//TODO: externalize this to a proper template function  
+//TODO:[WB] externalize this to a proper template function  
 #if deal_II_dimension > 1
   build_face_renumbering (FiniteElementData<dim-1>(FE_Q<dim-1>::get_dpo_vector(degree),1),
                          degree,
index d62d69e1d5e512ec7f6bdec88096b5b1abae68df..8febc2ce28ece03a03b326dd0168f8fbb458e1db 100644 (file)
@@ -27,7 +27,7 @@
 using namespace std;
 #endif
 
-//TODO: Remove obsolete data->compute_second_derivatives
+
 
 /* ----------------------- FESystem::InternalData ------------------- */
 
@@ -230,7 +230,6 @@ FESystem<dim>::clone() const
 }
 
 
-//TODO: remove update_second_derivatives from base elements
 
 template <int dim>
 UpdateFlags
index 09b897d8a7beaeb0a57a757b3a46b34d995b85c2..ceda68baf7cb87544aa29a80d76f22ca09ec9b94 100644 (file)
@@ -58,9 +58,10 @@ void FETools::get_interpolation_matrix(const FiniteElement<dim> &fe1,
                                   // This is a bad workaround as we
                                   // can't ask the FEs for their
                                   // shape values any more.
-// TODO: do this better. don't create a triangulation and dofhandler here!
+// TODO:[RH,GK] do this better. don't create a triangulation and dofhandler here!
 // maybe we can get it work by passing an end_iterator or something to the
-// FEValues::reinit function?  
+// FEValues::reinit function?
+// (if we have the second FEValues::reinit function, we at least no more need the DoFHandler object)  
   Triangulation<dim> tria;
   DoFHandler<dim> dof_handler(tria);
   GridGenerator::hyper_cube(tria);
index 8dc803e86842fa4da6b0ae61a3efb9de117605db..e20c30738f51b35887c712e674378df5c21d3e52 100644 (file)
@@ -32,7 +32,7 @@ using namespace std;
 #endif
 
 
-// TODO: replace this by non-global object
+// TODO:[RH,GK] replace this by non-global object
 static const MappingQ1<deal_II_dimension> mapping_q1;
 
 template <int dim>
@@ -410,7 +410,7 @@ template <int dim>
 unsigned int
 FEValuesBase<dim>::memory_consumption () const
 {
-//TODO: check whether this is up to date  
+//TODO:[WB] check whether this is up to date  
   return (MemoryConsumption::memory_consumption (shape_values) +
          MemoryConsumption::memory_consumption (shape_gradients) +
          MemoryConsumption::memory_consumption (shape_2nd_derivatives) +
@@ -425,7 +425,7 @@ FEValuesBase<dim>::memory_consumption () const
 /*------------------------------- FEValues -------------------------------*/
 
 
-// TODO: unify the two constructor bodies by calling a single function that does all the work
+// TODO:[GK,WB] unify the two constructor bodies by calling a single function that does all the work
 template <int dim>
 FEValues<dim>::FEValues (const Mapping<dim>       &mapping,
                         const FiniteElement<dim> &fe,
@@ -550,7 +550,7 @@ template <int dim>
 unsigned int
 FEValues<dim>::memory_consumption () const
 {
-//TODO: check whether this is up to date  
+//TODO:[WB] check whether this is up to date  
   return FEValuesBase<dim>::memory_consumption ();
 };
 
@@ -602,7 +602,7 @@ FEFaceValuesBase<dim>::get_boundary_forms () const
 /*------------------------------- FEFaceValues -------------------------------*/
 
 
-// TODO: unify the two constructor bodies by calling a single function that does all the work
+// TODO:[GK,WB] unify the two constructor bodies by calling a single function that does all the work
 template <int dim>
 FEFaceValues<dim>::FEFaceValues (const Mapping<dim>       &mapping,
                                 const FiniteElement<dim> &fe,
@@ -717,8 +717,8 @@ void FEFaceValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator &c
 /*------------------------------- FESubFaceValues -------------------------------*/
 
 
-// TODO: unify the two constructor bodies by calling a single function that does all the work
-// TODO: FESubfaceValues constructors are exactly the same as FEFaceValues constructors with exception of calling fe_sub_face_data instead of fe_face_data. Merge!
+// TODO:[GK,WB] unify the two constructor bodies by calling a single function that does all the work
+// TODO:[GK,WB] FESubfaceValues constructors are exactly the same as FEFaceValues constructors with exception of calling fe_sub_face_data instead of fe_face_data. Merge!
 template <int dim>
 FESubfaceValues<dim>::FESubfaceValues (const Mapping<dim>       &mapping,
                                       const FiniteElement<dim> &fe,
@@ -817,7 +817,7 @@ void FESubfaceValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator
   Assert (subface_no < GeometryInfo<dim>::subfaces_per_face,
          ExcIndexRange (subface_no, 0, GeometryInfo<dim>::subfaces_per_face));
 
-//TODO: Reinsert this assertion? It tests a necessary, not a sufficient condition
+//TODO:[GK] Reinsert this assertion? It tests a necessary, not a sufficient condition
   //  Assert (cell->face(face_no)->at_boundary() == false,
   //     ExcReinitCalledWithBoundaryFace());
   
index 8c2ab4ba12543351dea147ffc9b556465e447748..e30e77c75a60536f224892eca12afd537f05eb19 100644 (file)
@@ -106,7 +106,7 @@ MappingCartesian<dim>::compute_fill (const typename DoFHandler<dim>::cell_iterat
                                     std::vector<Point<dim> > &quadrature_points,
                                     std::vector<Point<dim> > &normal_vectors) const
 {
-//TODO: does it make sense to query the update flags in data if we did not set any in the get_*_data functions?
+//TODO:[GK] does it make sense to query the update flags in data if we did not set any in the get_*_data functions?
   UpdateFlags update_flags(data.current_update_flags());
 
   const unsigned int npts = quadrature_points.size ();
@@ -268,7 +268,7 @@ MappingCartesian<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator& cel
                                   // equal and are the product of the
                                   // local lengths in each coordinate
                                   // direction
-//TODO: does it make sense to query the update flags in data if we did not set any in the get_*_data functions?
+//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];
@@ -312,14 +312,14 @@ MappingCartesian<dim>::fill_fe_face_values (const typename DoFHandler<dim>::cell
     if (d != (normal_directions[face_no]/2))
       J *= data.length[d];
   
-//TODO: does it make sense to query the update flags in data if we did not set any in the get_*_data functions?
+//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: does it make sense to query the update flags in data if we did not set any in the get_*_data functions?
+//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)
@@ -360,14 +360,14 @@ MappingCartesian<dim>::fill_fe_subface_values (const typename DoFHandler<dim>::c
     if (d != (normal_directions[face_no]/2))
       J *= data.length[d];
   
-//TODO: does it make sense to query the update flags in data if we did not set any in the get_*_data functions?
+//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: does it make sense to query the update flags in data if we did not set any in the get_*_data functions?
+//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 a1004e0741cd7ac3816c825757b14b1689a5dd03..e2f009f245106d3e389532b6cf1b35ebd0c94010 100644 (file)
@@ -700,7 +700,7 @@ MappingQ<dim>::compute_mapping_support_points(
   if (use_mapping_q_on_all_cells || cell->has_boundary_lines())
     compute_support_points_laplace(cell, a);
 //  compute_support_points_simple(cell, a);
-//TODO: (later) can we delete the previous line?  
+//TODO:[RH] (later) can we delete the previous line?  
                                   // keep last line for easy
                                   // switching between the two
                                   // possible cases of computing the
@@ -761,7 +761,7 @@ MappingQ<dim>::compute_support_points_laplace(const typename Triangulation<dim>:
 
 
 
-//TODO: (later) remove the following function altogether
+//TODO:[RH] (later) remove the following function altogether
 template <int dim>
 void
 MappingQ<dim>::compute_support_points_simple(const typename Triangulation<dim>::cell_iterator &cell,
index 85730cf02ed59897a775bc2b6d793e318a79619c..a5c06d38a790eb0b64cb33d2164df7e4f1f56e2a 100644 (file)
@@ -297,7 +297,7 @@ MappingQ1<dim>::update_each (const UpdateFlags in) const
                                   // update_boundary_forms is simply
                                   // ignored for the interior of a
                                   // cell.
-//TODO: Consider giving this function information on whether we are on
+//TODO:[RH,GK] Consider giving this function information on whether we are on
 //  a face.
   if (out & (update_JxW_values
            |update_normal_vectors))
@@ -575,8 +575,8 @@ MappingQ1<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &cell,
   const std::vector<double> &weights=q.get_weights();
 
                                   // Multiply quadrature weights
-                                  // by Jaconian determinants
- //TODO: compute Jacobi determinants directly, if co/contravariant is not needed
+                                  // 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 0720790031426e4c24775d4b025eba980f3c8f0d..f77011673e86a981eaf996bf17841be56c1e958a 100644 (file)
@@ -239,7 +239,6 @@ void GridOut::write_gnuplot (const Triangulation<1> &tria,
     {
       if (gnuplot_flags.write_cell_numbers)
        out << "# cell " << cell << std::endl;
-//TODO: plot level and material according to switches      
 
       out << cell->vertex(0)
          << ' ' << cell->level()
@@ -290,7 +289,7 @@ void GridOut::write_gnuplot (const Triangulation<dim> &tria,
     {
       if (gnuplot_flags.write_cell_numbers)
        out << "# cell " << cell << std::endl;
-//TODO: plot level and material according to switches      
+
       switch (dim)
        {
          case 1:
@@ -396,7 +395,7 @@ void GridOut::write_gnuplot (const Triangulation<dim> &tria,
           
          case 3:
          {
-//TODO: curved boundaries in 3d gnuplot not supported      
+//TODO:[RH] curved boundaries in 3d gnuplot not supported          
            Assert (mapping == 0, ExcNotImplemented());
            
                                             // front face
@@ -650,7 +649,7 @@ void GridOut::write_eps (const Triangulation<dim> &tria,
       {
                                         // curved boundary output
                                         // presently not supported
-//TODO: curved boundaries in eps for 3d        
+//TODO:[RH] curved boundaries in eps for 3d    
        Assert (mapping == 0, ExcNotImplemented());
        
        Triangulation<dim>::active_line_iterator line   =tria.begin_active_line ();
index 137bac1ffb53d89ed915037a47a19585af9b4055..2e007adc6018e08559c1e38f764228a2545a5467 100644 (file)
@@ -1564,7 +1564,7 @@ void MGDoFHandler<1>::reserve_space () {
                                   // now allocate the needed space
   for (unsigned int vertex=0; vertex<tria->vertices.size(); ++vertex)
     {
-//TODO: These conditions are violated on unused vertices
+//TODO:[WB,GK] These conditions are violated on unused vertices
       Assert (min_level[vertex] < tria->n_levels(),   ExcInternalError());
       Assert (max_level[vertex] >= min_level[vertex], ExcInternalError());
 
@@ -1655,7 +1655,7 @@ void MGDoFHandler<2>::reserve_space () {
 // now allocate the needed space
   for (unsigned int vertex=0; vertex<tria->vertices.size(); ++vertex)
     {
-//TODO: These conditions are violated on unused vertices
+//TODO:[WB,GK] These conditions are violated on unused vertices
       Assert (min_level[vertex] < tria->n_levels(),   ExcInternalError());
       Assert (max_level[vertex] >= min_level[vertex], ExcInternalError());
 
@@ -1749,7 +1749,7 @@ void MGDoFHandler<3>::reserve_space () {
                                   // now allocate the needed space
   for (unsigned int vertex=0; vertex<tria->vertices.size(); ++vertex)
     {
-//TODO: These conditions are violated on unused vertices
+//TODO:[WB,GK] These conditions are violated on unused vertices
       Assert (min_level[vertex] < tria->n_levels(),   ExcInternalError());
       Assert (max_level[vertex] >= min_level[vertex], ExcInternalError());
 
index d72e776c1dffbbc7422af95b296467af50f03fcc..6ad73f4abc14313c8fd641a4175d2cda035ae8c9 100644 (file)
@@ -97,7 +97,7 @@ void MGTransferPrebuilt::build_matrices (const MGDoFHandler<dim> &mg_dof)
                                       // cell
       prolongation_sparsities.back().reinit (mg_dof.n_dofs(level+1),
                                             mg_dof.n_dofs(level),
-//TODO: evil hack, must be corrected!
+//TODO:[WB,GK] evil hack, must be corrected!
                                             dofs_per_cell+1);
       
       for (typename MGDoFHandler<dim>::cell_iterator cell=mg_dof.begin(level);
index 4090a09459fc698838a20116e6c3f34b54d5cbd5..66ddf28414f9f73a989c4109bfeec26cf457f37a 100644 (file)
@@ -24,7 +24,7 @@
 #include <fe/fe_values.h>
 #include <fe/mapping_q1.h>
 
-//TODO: Do this more clever
+//TODO:[RH,GK] Replace global by local object; better: have two functions, or by default arg
 static const MappingQ1<deal_II_dimension> mapping;
 
 #ifdef DEAL_II_USE_MT
index 83ec1fefd476fe11e1bfda8ebd200cd70c4900ca..0dc7e4644f7b9747482a1cd67b8aee39e3699ed1 100644 (file)
@@ -24,7 +24,7 @@
 
 #include <fe/mapping_q1.h>
 
-//TODO: Do this more clever
+//TODO:[RH,GK] Replace global by local object; better: have two functions, or by default arg
 static const MappingQ1<deal_II_dimension> mapping;
 
 #ifdef DEAL_II_USE_MT
index d1476267e21a25d7baa3dbcdbe4a3d1c88857046..94ffba66326665c5de04d343b9be0238d1f62c2c 100644 (file)
@@ -23,7 +23,7 @@
 #include <fe/fe.h>
 #include <fe/fe_values.h>
 
-//TODO: Do this more clever
+//TODO:[RH,GK] Replace global by local object; better: have two functions, or by default arg
 static const MappingQ1<deal_II_dimension> mapping;
 
 #ifdef DEAL_II_USE_MT
index 322f418c6025c17a3217f6771bdf6e67b08ee0f3..a8d56ef5e7f35299b944a182f5ebdd61a5ac10ae 100644 (file)
@@ -31,7 +31,7 @@ using namespace std;
 #endif
 
 
-//TODO: Comment?? Use proper mapping!
+//TODO:[RH,GK] Replace global by local object; better: have two functions, or by default arg
 static const MappingQ1<deal_II_dimension> mapping;
 
 
index 242ed0eb3a73d9b752f87424396ff8ef048dee1d..63c73f3ce837940c0f537272617d6ffd689986a5 100644 (file)
@@ -27,7 +27,7 @@
 #include <cmath>
 
 
-//TODO: Comment? Use proper mapping!
+//TODO:[RH,GK] Replace global by local object; better: have two functions, or by default arg
 static const MappingQ1<deal_II_dimension> mapping;
 
 
index 705a915da8ac61515505a14e234c856a9194a840..c4c7cef0046f4a46903b16e076ce321a14ce9bd1 100644 (file)
@@ -39,7 +39,7 @@ using namespace std;
 
 
 
-//TODO: Comment?? Proper Mapping
+//TODO:[RH,GK] Replace global by local object; better: have two functions, or by default arg
 static const MappingQ1<deal_II_dimension> mapping;
 
 
index 004bac89b10077afce27f76c3d412c35d822bc1c..3c81a0d92f31a421aac11c601f5285afced13613 100644 (file)
@@ -40,12 +40,12 @@ using namespace std;
 
 
 
-//TODO: Comment?? Use proper mapping!
+//TODO:[RH,GK] Replace global by local object; better: have two functions, or by default arg
 static const MappingQ1<deal_II_dimension> mapping_q1;
 
 
 
-//TODO: re-create the create_mass_matrix function with 2 args
+//TODO:[RH,GK] maybe re-create the create_mass_matrix function with 2 args
 
 template <int dim>
 void MatrixCreator<dim>::create_mass_matrix (const DoFHandler<dim>    &dof,
@@ -577,7 +577,7 @@ void MatrixCreator<dim>::create_laplace_matrix (const DoFHandler<dim>    &dof,
 
 
 
-//TODO: recreate this function
+//TODO:[GK,RH] maybe recreate this function
 /*
 
 template <int dim>
index c41ef605e24c4b273d6d7c043befb5ffb7758fe5..77f125b6a7574bf4aec113631d9f7371d04232e3 100644 (file)
@@ -43,7 +43,7 @@ using namespace std;
 
 
 
-//TODO: Comment?? Use proper mapping!
+//TODO:[RH,GK] Replace global by local object; better: have two functions, or by default arg
 static const MappingQ1<deal_II_dimension> mapping_q1;
 
 

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.