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

deal.II/base/include/base/polynomial.h
deal.II/base/include/base/quadrature.h
deal.II/lac/include/lac/eigen.h
deal.II/lac/include/lac/precondition.h
deal.II/lac/include/lac/solver.h
deal.II/lac/include/lac/solver_bicgstab.h
deal.II/lac/include/lac/solver_gmres.h

index c32f1a4b3023fef3139b6a9bd86ce4ab86f7570f..ff327658ee472c02b94adf039f5959acbb3c7883 100644 (file)
@@ -173,7 +173,7 @@ class LagrangeEquidistant: public Polynomial<double>
  *
  * @author Guido Kanschat, 2000
  */
-//TODO: test this class Legendre, it has never been tested up to now
+//TODO:[GK] test this class Legendre, it has never been tested up to now
 template <typename number>
 class Legendre : public Polynomial<number>
 {
index c7ae96e060e2598fae02d0a2ef43aaab8224beaa..0191de9b0246434594b6db3bbfed34e11ba8cabc 100644 (file)
@@ -252,7 +252,7 @@ template <int dim>
 class QProjector : public Quadrature<dim>
 {
   public:
-//TODO: remove this constructor again and return to old state with static-only functions. move this function to something in the finite element classes which is the only place where it is used.    
+//TODO:[GK] remove this constructor again and return to old state with static-only functions. move this function to something in the finite element classes which is the only place where it is used.    
                                     /**
                                      * Constructor for a quadrature rule on all (sub)faces.
                                      * The quadrature rule
index c25a284510cd45705718f3e93074d41086c082f9..3eb0ce291df9b1392e5053c422976844087c56f7 100644 (file)
@@ -151,7 +151,7 @@ class EigenPower : private Solver<VECTOR>
     AdditionalData additional_data;
 };
 
-//TODO: Finish documentation after fixing parameters.
+//TODO:[GK] Finish documentation after fixing parameters.
 
 /**
  * Inverse iteration (Wieland).
index 320da0ddb25ac4950e7a439ca701914a606310b4..4c6e271e6a02852bf1764e9c95c90ecc75671dd2 100644 (file)
@@ -432,7 +432,7 @@ class PreconditionLACSolver : public Subscriptor
     const PRECONDITION* precondition;
 };
 
-//TODO: Use SmartPointer for SOLVER and PRECONDITION above?
+//TODO:[?] Use SmartPointer for SOLVER and PRECONDITION above?
 // Another Subscriptor?
 
 
index f00ae974897032add80621272a79062c8ae284dd..f76a65bfff5a5b7fecb94bd423e0ff4ef9c4b82c 100644 (file)
@@ -21,7 +21,7 @@ class SolverControl;
 /**
  * Base class for iterative solvers.
  *
-//TODO: * HAS TO BE UPDATED!
+//TODO:[?] * HAS TO BE UPDATED!
  *
  * This class defines possible
  * return states of linear solvers and provides interfaces to a memory
index c1ba84be95ebe2b142bd837d236515acacd17a29..fb5b13040e687e76176c9cc0661cff5ff4b195fa 100644 (file)
@@ -308,7 +308,7 @@ SolverBicgstab<VECTOR>::iterate(const MATRIX& A,
 
       alpha = rho/rhobar;
 
-//TODO: Find better breakdown criterion (G)
+//TODO:[GK] Find better breakdown criterion
 
       if (fabs(alpha) > 1.e10)
        return typename Solver<VECTOR>::ReturnState(breakdown);
index 7596c4cc6fad42b71f3298435f1e8604d41557e2..5fb7bf9ddfb6194be90d110bed305095cb1d7373 100644 (file)
@@ -195,23 +195,15 @@ SolverGMRES<VECTOR>::solve (const MATRIX& A,
                                   const VECTOR& b,
                                   const PRECONDITIONER& precondition)
 {
-                                  // this code was written by the fathers of
-                                  // DEAL. I take absolutely no guarantees
-                                  // for any failures or airplane-explosions
-                                  // or nuclear wars or whatever resulting
-                                  // from this code. I tried to clean a bit,
-                                  // but whoever wrote this code in the first
-                                  // place should get stoned, IMHO! (WB)
-
-                                  // This code was definitely NOT
-                                  // written by the fathers of DEAL
-                                  // and it is very unclear to me,
-                                  // why such a strange piece of code
-                                  // should be here. It has a lot of
-                                  // flaws, the old GMRES of DEAL did
-                                  // not have. (GK)
-//TODO: Check, why there are two different start residuals.
-//TODO: Allocate vectors only when needed.
+                                  // this code was written a very
+                                  // long time ago by people not
+                                  // associated with deal.II. we
+                                  // don't make any guarantees to its
+                                  // optimality or that it even works
+                                  // as expected...
+  
+//TODO:[?] Check, why there are two different start residuals.
+//TODO:[?] Allocate vectors only when needed.
 
   deallog.push("GMRES");
 

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.