From: wolf Date: Thu, 29 Mar 2001 14:59:33 +0000 (+0000) Subject: Assign names to TODOs. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=b99fb499c70d7a90b4dbdd58d56a7214cad08050;p=dealii-svn.git Assign names to TODOs. git-svn-id: https://svn.dealii.org/trunk@4332 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/deal.II/include/fe/fe_base.h b/deal.II/deal.II/include/fe/fe_base.h index 23310a5632..38249308b5 100644 --- a/deal.II/deal.II/include/fe/fe_base.h +++ b/deal.II/deal.II/include/fe/fe_base.h @@ -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 diff --git a/deal.II/deal.II/include/fe/fe_dgq.h b/deal.II/deal.II/include/fe/fe_dgq.h index dedbb0b76d..e5b6266ff1 100644 --- a/deal.II/deal.II/include/fe/fe_dgq.h +++ b/deal.II/deal.II/include/fe/fe_dgq.h @@ -22,7 +22,7 @@ template 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 class FE_DGQ : public FiniteElement @@ -196,7 +196,7 @@ class FE_DGQ : public FiniteElement /** * Compute renumbering for rotation * of degrees of freedom. -//TODO: meaning of direction=[zZxXyY] +//TODO:[GK] meaning of direction=[zZxXyY] */ void rotate_indices (std::vector &indices, const char direction = 'y') const; @@ -254,7 +254,7 @@ class FE_DGQ : public FiniteElement * 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*> differences; }; diff --git a/deal.II/deal.II/include/fe/fe_lib.dg.h b/deal.II/deal.II/include/fe/fe_lib.dg.h index 0405db77ef..fcdb94dacd 100644 --- a/deal.II/deal.II/include/fe/fe_lib.dg.h +++ b/deal.II/deal.II/include/fe/fe_lib.dg.h @@ -17,7 +17,7 @@ #include -//TODO: briefly document classes and mark them deprecated +//TODO:[WB,RH] briefly document classes and mark them deprecated template class FEDG_Q0: public FE_DGQ diff --git a/deal.II/deal.II/include/fe/fe_lib.lagrange.h b/deal.II/deal.II/include/fe/fe_lib.lagrange.h index 52ab4aefed..61129b3c33 100644 --- a/deal.II/deal.II/include/fe/fe_lib.lagrange.h +++ b/deal.II/deal.II/include/fe/fe_lib.lagrange.h @@ -17,7 +17,7 @@ #include -//TODO: briefly document classes and mark them deprecated +//TODO:[WB,RH] briefly document classes and mark them deprecated template class FEQ1: public FE_Q diff --git a/deal.II/deal.II/include/fe/fe_q.h b/deal.II/deal.II/include/fe/fe_q.h index 04206bf33a..6c8e6f9aca 100644 --- a/deal.II/deal.II/include/fe/fe_q.h +++ b/deal.II/deal.II/include/fe/fe_q.h @@ -23,7 +23,7 @@ template 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 class FE_Q : public FiniteElement @@ -40,7 +40,7 @@ class FE_Q : public FiniteElement */ ~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. diff --git a/deal.II/deal.II/include/fe/fe_values.h b/deal.II/deal.II/include/fe/fe_values.h index b545207fce..554c26ec77 100644 --- a/deal.II/deal.II/include/fe/fe_values.h +++ b/deal.II/deal.II/include/fe/fe_values.h @@ -244,7 +244,7 @@ class FEValuesBase : protected FEValuesData * 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, diff --git a/deal.II/deal.II/include/fe/mapping_q.h b/deal.II/deal.II/include/fe/mapping_q.h index d894a80537..8e2d3c8602 100644 --- a/deal.II/deal.II/include/fe/mapping_q.h +++ b/deal.II/deal.II/include/fe/mapping_q.h @@ -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 * 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::cell_iterator &cell, std::vector > &a) const; diff --git a/deal.II/deal.II/include/multigrid/mg_dof_handler.h b/deal.II/deal.II/include/multigrid/mg_dof_handler.h index 25215179eb..9c1d0d37ae 100644 --- a/deal.II/deal.II/include/multigrid/mg_dof_handler.h +++ b/deal.II/deal.II/include/multigrid/mg_dof_handler.h @@ -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 */ diff --git a/deal.II/deal.II/include/multigrid/mg_dof_tools.h b/deal.II/deal.II/include/multigrid/mg_dof_tools.h index baa8febe27..5747621f25 100644 --- a/deal.II/deal.II/include/multigrid/mg_dof_tools.h +++ b/deal.II/deal.II/include/multigrid/mg_dof_tools.h @@ -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 diff --git a/deal.II/deal.II/include/multigrid/multigrid.h b/deal.II/deal.II/include/multigrid/multigrid.h index 068e16106e..e5dc0ff3b9 100644 --- a/deal.II/deal.II/include/multigrid/multigrid.h +++ b/deal.II/deal.II/include/multigrid/multigrid.h @@ -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 &mg_dof_handler, const ConstraintMatrix &constraints, const MGLevelObject &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 &dest, const Vector &src, diff --git a/deal.II/deal.II/include/multigrid/multigrid.templates.h b/deal.II/deal.II/include/multigrid/multigrid.templates.h index 97d708547f..7385e2a39a 100644 --- a/deal.II/deal.II/include/multigrid/multigrid.templates.h +++ b/deal.II/deal.II/include/multigrid/multigrid.templates.h @@ -23,7 +23,7 @@ #include -//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 @@ -84,7 +84,7 @@ Multigrid::copy_to_mg (const Vector& osrc) const MGDoFHandler::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. diff --git a/deal.II/deal.II/include/numerics/vectors.h b/deal.II/deal.II/include/numerics/vectors.h index 8ccd50bcd3..cee7163710 100644 --- a/deal.II/deal.II/include/numerics/vectors.h +++ b/deal.II/deal.II/include/numerics/vectors.h @@ -450,8 +450,8 @@ class VectorTools std::map &boundary_values, const std::vector &component_mask = std::vector()); -//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 &v, const std::vector &p_select); diff --git a/deal.II/deal.II/source/fe/fe_dgq.cc b/deal.II/deal.II/source/fe/fe_dgq.cc index baef366214..62362176fa 100644 --- a/deal.II/deal.II/source/fe/fe_dgq.cc +++ b/deal.II/deal.II/source/fe/fe_dgq.cc @@ -345,7 +345,7 @@ FE_DGQ::rotate_indices (std::vector &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 ()); } } diff --git a/deal.II/deal.II/source/fe/fe_q.cc b/deal.II/deal.II/source/fe/fe_q.cc index 24a8ab12f8..afd4c35ad4 100644 --- a/deal.II/deal.II/source/fe/fe_q.cc +++ b/deal.II/deal.II/source/fe/fe_q.cc @@ -25,7 +25,7 @@ -//TODO: move build_renumbering to mapping class +//TODO:[RH] move build_renumbering to mapping class template FE_Q::FE_Q (const unsigned int degree) @@ -49,7 +49,7 @@ FE_Q::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(FE_Q::get_dpo_vector(degree),1), degree, diff --git a/deal.II/deal.II/source/fe/fe_system.cc b/deal.II/deal.II/source/fe/fe_system.cc index d62d69e1d5..8febc2ce28 100644 --- a/deal.II/deal.II/source/fe/fe_system.cc +++ b/deal.II/deal.II/source/fe/fe_system.cc @@ -27,7 +27,7 @@ using namespace std; #endif -//TODO: Remove obsolete data->compute_second_derivatives + /* ----------------------- FESystem::InternalData ------------------- */ @@ -230,7 +230,6 @@ FESystem::clone() const } -//TODO: remove update_second_derivatives from base elements template UpdateFlags diff --git a/deal.II/deal.II/source/fe/fe_tools.cc b/deal.II/deal.II/source/fe/fe_tools.cc index 09b897d8a7..ceda68baf7 100644 --- a/deal.II/deal.II/source/fe/fe_tools.cc +++ b/deal.II/deal.II/source/fe/fe_tools.cc @@ -58,9 +58,10 @@ void FETools::get_interpolation_matrix(const FiniteElement &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 tria; DoFHandler dof_handler(tria); GridGenerator::hyper_cube(tria); diff --git a/deal.II/deal.II/source/fe/fe_values.cc b/deal.II/deal.II/source/fe/fe_values.cc index 8dc803e868..e20c30738f 100644 --- a/deal.II/deal.II/source/fe/fe_values.cc +++ b/deal.II/deal.II/source/fe/fe_values.cc @@ -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 mapping_q1; template @@ -410,7 +410,7 @@ template unsigned int FEValuesBase::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::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 FEValues::FEValues (const Mapping &mapping, const FiniteElement &fe, @@ -550,7 +550,7 @@ template unsigned int FEValues::memory_consumption () const { -//TODO: check whether this is up to date +//TODO:[WB] check whether this is up to date return FEValuesBase::memory_consumption (); }; @@ -602,7 +602,7 @@ FEFaceValuesBase::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 FEFaceValues::FEFaceValues (const Mapping &mapping, const FiniteElement &fe, @@ -717,8 +717,8 @@ void FEFaceValues::reinit (const typename DoFHandler::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 FESubfaceValues::FESubfaceValues (const Mapping &mapping, const FiniteElement &fe, @@ -817,7 +817,7 @@ void FESubfaceValues::reinit (const typename DoFHandler::cell_iterator Assert (subface_no < GeometryInfo::subfaces_per_face, ExcIndexRange (subface_no, 0, GeometryInfo::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()); diff --git a/deal.II/deal.II/source/fe/mapping_cartesian.cc b/deal.II/deal.II/source/fe/mapping_cartesian.cc index 8c2ab4ba12..e30e77c75a 100644 --- a/deal.II/deal.II/source/fe/mapping_cartesian.cc +++ b/deal.II/deal.II/source/fe/mapping_cartesian.cc @@ -106,7 +106,7 @@ MappingCartesian::compute_fill (const typename DoFHandler::cell_iterat std::vector > &quadrature_points, std::vector > &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::fill_fe_values (const DoFHandler::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::fill_fe_face_values (const typename DoFHandler::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::fill_fe_subface_values (const typename DoFHandler::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::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::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::compute_support_points_laplace(const typename Triangulation: -//TODO: (later) remove the following function altogether +//TODO:[RH] (later) remove the following function altogether template void MappingQ::compute_support_points_simple(const typename Triangulation::cell_iterator &cell, diff --git a/deal.II/deal.II/source/fe/mapping_q1.cc b/deal.II/deal.II/source/fe/mapping_q1.cc index 85730cf02e..a5c06d38a7 100644 --- a/deal.II/deal.II/source/fe/mapping_q1.cc +++ b/deal.II/deal.II/source/fe/mapping_q1.cc @@ -297,7 +297,7 @@ MappingQ1::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::fill_fe_values (const DoFHandler::cell_iterator &cell, const std::vector &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, diff --git a/deal.II/deal.II/source/grid/grid_out.cc b/deal.II/deal.II/source/grid/grid_out.cc index 0720790031..f77011673e 100644 --- a/deal.II/deal.II/source/grid/grid_out.cc +++ b/deal.II/deal.II/source/grid/grid_out.cc @@ -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 &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 &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 &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::active_line_iterator line =tria.begin_active_line (); diff --git a/deal.II/deal.II/source/multigrid/mg_dof_handler.cc b/deal.II/deal.II/source/multigrid/mg_dof_handler.cc index 137bac1ffb..2e007adc60 100644 --- a/deal.II/deal.II/source/multigrid/mg_dof_handler.cc +++ b/deal.II/deal.II/source/multigrid/mg_dof_handler.cc @@ -1564,7 +1564,7 @@ void MGDoFHandler<1>::reserve_space () { // now allocate the needed space for (unsigned int vertex=0; vertexvertices.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; vertexvertices.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; vertexvertices.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()); diff --git a/deal.II/deal.II/source/multigrid/multigrid.cc b/deal.II/deal.II/source/multigrid/multigrid.cc index d72e776c1d..6ad73f4abc 100644 --- a/deal.II/deal.II/source/multigrid/multigrid.cc +++ b/deal.II/deal.II/source/multigrid/multigrid.cc @@ -97,7 +97,7 @@ void MGTransferPrebuilt::build_matrices (const MGDoFHandler &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::cell_iterator cell=mg_dof.begin(level); diff --git a/deal.II/deal.II/source/numerics/data_out.cc b/deal.II/deal.II/source/numerics/data_out.cc index 4090a09459..66ddf28414 100644 --- a/deal.II/deal.II/source/numerics/data_out.cc +++ b/deal.II/deal.II/source/numerics/data_out.cc @@ -24,7 +24,7 @@ #include #include -//TODO: Do this more clever +//TODO:[RH,GK] Replace global by local object; better: have two functions, or by default arg static const MappingQ1 mapping; #ifdef DEAL_II_USE_MT diff --git a/deal.II/deal.II/source/numerics/data_out_faces.cc b/deal.II/deal.II/source/numerics/data_out_faces.cc index 83ec1fefd4..0dc7e4644f 100644 --- a/deal.II/deal.II/source/numerics/data_out_faces.cc +++ b/deal.II/deal.II/source/numerics/data_out_faces.cc @@ -24,7 +24,7 @@ #include -//TODO: Do this more clever +//TODO:[RH,GK] Replace global by local object; better: have two functions, or by default arg static const MappingQ1 mapping; #ifdef DEAL_II_USE_MT diff --git a/deal.II/deal.II/source/numerics/data_out_rotation.cc b/deal.II/deal.II/source/numerics/data_out_rotation.cc index d1476267e2..94ffba6632 100644 --- a/deal.II/deal.II/source/numerics/data_out_rotation.cc +++ b/deal.II/deal.II/source/numerics/data_out_rotation.cc @@ -23,7 +23,7 @@ #include #include -//TODO: Do this more clever +//TODO:[RH,GK] Replace global by local object; better: have two functions, or by default arg static const MappingQ1 mapping; #ifdef DEAL_II_USE_MT diff --git a/deal.II/deal.II/source/numerics/data_out_stack.cc b/deal.II/deal.II/source/numerics/data_out_stack.cc index 322f418c60..a8d56ef5e7 100644 --- a/deal.II/deal.II/source/numerics/data_out_stack.cc +++ b/deal.II/deal.II/source/numerics/data_out_stack.cc @@ -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 mapping; diff --git a/deal.II/deal.II/source/numerics/derivative_approximation.cc b/deal.II/deal.II/source/numerics/derivative_approximation.cc index 242ed0eb3a..63c73f3ce8 100644 --- a/deal.II/deal.II/source/numerics/derivative_approximation.cc +++ b/deal.II/deal.II/source/numerics/derivative_approximation.cc @@ -27,7 +27,7 @@ #include -//TODO: Comment? Use proper mapping! +//TODO:[RH,GK] Replace global by local object; better: have two functions, or by default arg static const MappingQ1 mapping; diff --git a/deal.II/deal.II/source/numerics/error_estimator.cc b/deal.II/deal.II/source/numerics/error_estimator.cc index 705a915da8..c4c7cef004 100644 --- a/deal.II/deal.II/source/numerics/error_estimator.cc +++ b/deal.II/deal.II/source/numerics/error_estimator.cc @@ -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 mapping; diff --git a/deal.II/deal.II/source/numerics/matrices.cc b/deal.II/deal.II/source/numerics/matrices.cc index 004bac89b1..3c81a0d92f 100644 --- a/deal.II/deal.II/source/numerics/matrices.cc +++ b/deal.II/deal.II/source/numerics/matrices.cc @@ -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 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 void MatrixCreator::create_mass_matrix (const DoFHandler &dof, @@ -577,7 +577,7 @@ void MatrixCreator::create_laplace_matrix (const DoFHandler &dof, -//TODO: recreate this function +//TODO:[GK,RH] maybe recreate this function /* template diff --git a/deal.II/deal.II/source/numerics/vectors.cc b/deal.II/deal.II/source/numerics/vectors.cc index c41ef605e2..77f125b6a7 100644 --- a/deal.II/deal.II/source/numerics/vectors.cc +++ b/deal.II/deal.II/source/numerics/vectors.cc @@ -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 mapping_q1;