From 91fda0554d2817c17ab04c59d1984869f792c499 Mon Sep 17 00:00:00 2001 From: wolf Date: Thu, 29 Mar 2001 14:31:34 +0000 Subject: [PATCH] Assign names to TODOs. git-svn-id: https://svn.dealii.org/trunk@4327 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/base/include/base/polynomial.h | 2 +- deal.II/base/include/base/quadrature.h | 2 +- deal.II/lac/include/lac/eigen.h | 2 +- deal.II/lac/include/lac/precondition.h | 2 +- deal.II/lac/include/lac/solver.h | 2 +- deal.II/lac/include/lac/solver_bicgstab.h | 2 +- deal.II/lac/include/lac/solver_gmres.h | 26 ++++++++--------------- 7 files changed, 15 insertions(+), 23 deletions(-) diff --git a/deal.II/base/include/base/polynomial.h b/deal.II/base/include/base/polynomial.h index c32f1a4b30..ff327658ee 100644 --- a/deal.II/base/include/base/polynomial.h +++ b/deal.II/base/include/base/polynomial.h @@ -173,7 +173,7 @@ class LagrangeEquidistant: public Polynomial * * @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 class Legendre : public Polynomial { diff --git a/deal.II/base/include/base/quadrature.h b/deal.II/base/include/base/quadrature.h index c7ae96e060..0191de9b02 100644 --- a/deal.II/base/include/base/quadrature.h +++ b/deal.II/base/include/base/quadrature.h @@ -252,7 +252,7 @@ template class QProjector : public Quadrature { 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 diff --git a/deal.II/lac/include/lac/eigen.h b/deal.II/lac/include/lac/eigen.h index c25a284510..3eb0ce291d 100644 --- a/deal.II/lac/include/lac/eigen.h +++ b/deal.II/lac/include/lac/eigen.h @@ -151,7 +151,7 @@ class EigenPower : private Solver AdditionalData additional_data; }; -//TODO: Finish documentation after fixing parameters. +//TODO:[GK] Finish documentation after fixing parameters. /** * Inverse iteration (Wieland). diff --git a/deal.II/lac/include/lac/precondition.h b/deal.II/lac/include/lac/precondition.h index 320da0ddb2..4c6e271e6a 100644 --- a/deal.II/lac/include/lac/precondition.h +++ b/deal.II/lac/include/lac/precondition.h @@ -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? diff --git a/deal.II/lac/include/lac/solver.h b/deal.II/lac/include/lac/solver.h index f00ae97489..f76a65bfff 100644 --- a/deal.II/lac/include/lac/solver.h +++ b/deal.II/lac/include/lac/solver.h @@ -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 diff --git a/deal.II/lac/include/lac/solver_bicgstab.h b/deal.II/lac/include/lac/solver_bicgstab.h index c1ba84be95..fb5b13040e 100644 --- a/deal.II/lac/include/lac/solver_bicgstab.h +++ b/deal.II/lac/include/lac/solver_bicgstab.h @@ -308,7 +308,7 @@ SolverBicgstab::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::ReturnState(breakdown); diff --git a/deal.II/lac/include/lac/solver_gmres.h b/deal.II/lac/include/lac/solver_gmres.h index 7596c4cc6f..5fb7bf9ddf 100644 --- a/deal.II/lac/include/lac/solver_gmres.h +++ b/deal.II/lac/include/lac/solver_gmres.h @@ -195,23 +195,15 @@ SolverGMRES::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"); -- 2.39.5