From: bangerth Date: Thu, 24 Jun 2010 23:38:14 +0000 (+0000) Subject: Remove references to tutorial programs that weren't ready yet. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=88c721412b73c4d82ef3417c17ef61cbf9cf1704;p=dealii-svn.git Remove references to tutorial programs that weren't ready yet. git-svn-id: https://svn.dealii.org/branches/releases/Branch-6-3@21358 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/base/include/base/conditional_ostream.h b/deal.II/base/include/base/conditional_ostream.h index bc7dafbd56..c763f6b121 100644 --- a/deal.II/base/include/base/conditional_ostream.h +++ b/deal.II/base/include/base/conditional_ostream.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2004, 2005, 2006, 2007, 2008, 2009 by the deal.II authors +// Copyright (C) 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -29,7 +29,7 @@ DEAL_II_NAMESPACE_OPEN * depending on the ConditionalOStream object being active (default) * or not. The condition of this object can be changed by * set_condition() and in the constructor. This class is used in the - * step-17, step-18, step-32, + * step-17, step-18, * step-33, and step-35 * tutorial programs. * diff --git a/deal.II/base/include/base/timer.h b/deal.II/base/include/base/timer.h index 26775ee1a2..7adef1327c 100644 --- a/deal.II/base/include/base/timer.h +++ b/deal.II/base/include/base/timer.h @@ -349,8 +349,6 @@ class Timer * object. In this case, we did a lot of other stuff, so that the time * proportions of the functions we measured are far away from 100 precent. * - * See the step-32 tutorial program for usage of this class. - * * @ingroup utilities * @author M. Kronbichler, 2009. */ diff --git a/deal.II/base/include/base/utilities.h b/deal.II/base/include/base/utilities.h index ee7d56796c..fd77d3cdd0 100644 --- a/deal.II/base/include/base/utilities.h +++ b/deal.II/base/include/base/utilities.h @@ -348,9 +348,6 @@ namespace Utilities * destructor of this object which in * turns calls MPI_Finalize * to shut down the MPI system. - * - * This class is used in @ref step_32 - * "step-32", for example. */ class MPI_InitFinalize { @@ -411,8 +408,7 @@ namespace Utilities * provides a unified interface to both serial and %parallel * implementations of Trilinos, sets up the MPI communicator in case the * programs are run in %parallel, and correctly terminates all processes - * when the destructor is called. An example usage of this class is shown - * in the tutorial program step-32. + * when the destructor is called. */ #ifdef DEAL_II_USE_TRILINOS namespace Trilinos diff --git a/deal.II/deal.II/include/dofs/dof_tools.h b/deal.II/deal.II/include/dofs/dof_tools.h index 5aa9a647e3..28ff513f2c 100644 --- a/deal.II/deal.II/include/dofs/dof_tools.h +++ b/deal.II/deal.II/include/dofs/dof_tools.h @@ -445,8 +445,7 @@ class DoFTools * builds that part of the sparsity * pattern that corresponds to the * subdomain_id for which it is - * responsible. This feature is - * step-32. + * responsible. */ template static @@ -601,8 +600,7 @@ class DoFTools * builds that part of the sparsity * pattern that corresponds to the * subdomain_id for which it is - * responsible. This feature is - * step-32. + * responsible. */ template static @@ -1421,9 +1419,8 @@ class DoFTools * case, an assertion is thrown. * * This function is used in the - * step-22, - * step-31, and - * step-32 tutorial + * step-22 and + * step-31 tutorial * programs. */ template diff --git a/deal.II/deal.II/include/grid/filtered_iterator.h b/deal.II/deal.II/include/grid/filtered_iterator.h index 0a7fb90297..e76b9aa737 100644 --- a/deal.II/deal.II/include/grid/filtered_iterator.h +++ b/deal.II/deal.II/include/grid/filtered_iterator.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007, 2009 by the deal.II authors +// Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -48,7 +48,7 @@ namespace IteratorFilters * * @ingroup Iterators */ - class Active + class Active { public: /** @@ -59,7 +59,7 @@ namespace IteratorFilters template bool operator () (const Iterator &i) const; }; - + /** * Filter that evaluates to true if * either the iterator points to an @@ -81,7 +81,7 @@ namespace IteratorFilters template bool operator () (const Iterator &i) const; }; - + /** * Filter that evaluates to true if @@ -106,7 +106,7 @@ namespace IteratorFilters bool operator () (const Iterator &i) const; }; - + /** * Filter for iterators that * evaluates to true if either the @@ -117,7 +117,7 @@ namespace IteratorFilters * * @ingroup Iterators */ - class LevelEqualTo + class LevelEqualTo { public: /** @@ -161,7 +161,7 @@ namespace IteratorFilters * * @ingroup Iterators */ - class SubdomainEqualTo + class SubdomainEqualTo { public: /** @@ -208,8 +208,7 @@ namespace IteratorFilters * called with a pair of iterators denoting a range on which they * shall act, by choosing a filtered iterator instead of usual ones. * - * This class is used in step-18 and - * step-32. + * This class is used in step-18. * * *

Predicates

@@ -245,7 +244,7 @@ namespace IteratorFilters * { * return (static_cast(c->level()) == level); * }; - * @endcode + * @endcode * then * @code * std::bind2nd (std::ptr_fun(&level_equal_to), 3) @@ -257,7 +256,7 @@ namespace IteratorFilters * * Finally, classes can be predicates. The following class is one: * @code - * class Active + * class Active * { * public: * template @@ -432,7 +431,7 @@ class FilteredIterator : public BaseIterator * will automatically be advanced * to the first cell that has. */ - template + template FilteredIterator (Predicate p, const BaseIterator &bi); @@ -447,7 +446,7 @@ class FilteredIterator : public BaseIterator * Destructor. */ ~FilteredIterator (); - + /** * Assignment operator. Copy the * iterator value of the @@ -490,7 +489,7 @@ class FilteredIterator : public BaseIterator */ FilteredIterator & set_to_next_positive (const BaseIterator &bi); - + /** * As above, but search for the * previous iterator from @p bi @@ -507,7 +506,7 @@ class FilteredIterator : public BaseIterator */ FilteredIterator & set_to_previous_positive (const BaseIterator &bi); - + /** * Compare for equality of the * underlying iterator values of @@ -559,7 +558,7 @@ class FilteredIterator : public BaseIterator * * We do not compare the * predicates. - */ + */ bool operator < (const FilteredIterator &fi) const; /** @@ -618,7 +617,7 @@ class FilteredIterator : public BaseIterator << "The element " << arg1 << " with which you want to compare or which you want to" << " assign from is invalid since it does not satisfy the predicate."); - + private: /** @@ -705,7 +704,7 @@ class FilteredIterator : public BaseIterator * type of this pointer. */ virtual PredicateBase * clone () const; - + private: /** * Copy of the predicate. @@ -830,7 +829,7 @@ FilteredIterator:: operator = (const BaseIterator &bi) { Assert ((bi.state() != IteratorState::valid) || (*predicate)(bi), - ExcInvalidElement(bi)); + ExcInvalidElement(bi)); BaseIterator::operator = (bi); return *this; } @@ -847,7 +846,7 @@ set_to_next_positive (const BaseIterator &bi) while ((this->state() == IteratorState::valid) && ( ! (*predicate)(*this))) BaseIterator::operator++ (); - + return *this; } @@ -863,7 +862,7 @@ set_to_previous_positive (const BaseIterator &bi) while ((this->state() == IteratorState::valid) && ( ! (*predicate)(*this))) BaseIterator::operator-- (); - + return *this; } @@ -964,7 +963,7 @@ FilteredIterator:: operator ++ (int) { const FilteredIterator old_state = *this; - + if (this->state() == IteratorState::valid) do BaseIterator::operator++ (); @@ -999,7 +998,7 @@ FilteredIterator:: operator -- (int) { const FilteredIterator old_state = *this; - + if (this->state() == IteratorState::valid) do BaseIterator::operator-- (); @@ -1043,7 +1042,7 @@ clone () const -namespace IteratorFilters +namespace IteratorFilters { // ---------------- IteratorFilters::Active --------- @@ -1079,7 +1078,7 @@ namespace IteratorFilters } -// ---------------- IteratorFilters::LevelEqualTo --------- +// ---------------- IteratorFilters::LevelEqualTo --------- inline LevelEqualTo::LevelEqualTo (const unsigned int level) : diff --git a/deal.II/doc/doxygen/headers/geodynamics.h b/deal.II/doc/doxygen/headers/geodynamics.h index 47afee7243..337924f2f6 100644 --- a/deal.II/doc/doxygen/headers/geodynamics.h +++ b/deal.II/doc/doxygen/headers/geodynamics.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2009 by the deal.II authors +// Copyright (C) 2009, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -33,7 +33,6 @@ programs: - step-21: Multiphase flow through porous media - step-22: Stokes flow - step-31: Thermal convection (Boussinesq flow) -- step-32: A %parallel Boussinesq solver for mantle convection Some of these programs were developed under contract from the California Institute of Technology with support by the National Science Foundation @@ -122,7 +121,7 @@ problems. In particular, they are aimed at the following goals: correctness. Existing tutorial programs typically employ simpler rather than more complicated solver schemes for exposition but frequently suggest more complicated schemes including hints on how they might be implemented in an - appendix. + appendix.
  • Try algorithms: The rapid prototyping abilities of deal.II may also help in determining best algorithms on the scale of programs to which diff --git a/deal.II/doc/doxygen/headers/glossary.h b/deal.II/doc/doxygen/headers/glossary.h index 20b4557775..dfc8ca7628 100644 --- a/deal.II/doc/doxygen/headers/glossary.h +++ b/deal.II/doc/doxygen/headers/glossary.h @@ -632,7 +632,7 @@ Article{JK10, * a vector-valued element has exactly one nonzero component if an element is * primitive. This includes, in particular, all scalar elements as well as * vector-valued elements assembled via the FESystem class from other - * primitive (for example scalar) elements as shown in step-8, + * primitive (for example scalar) elements as shown in step-8, * step-29, step-22 and several others. On the other hand, * the FE_RaviartThomas class used in step-20 and step-21, or the FE_Nedelec * class provide non-primitive finite elements because there, each @@ -659,8 +659,8 @@ Article{JK10, * cell is associated with. * * For programs that are parallelized based on MPI but where each processor - * stores the entire triangulation (as in, for example, step-18 - * or step-32, subdomain ids are assigned to cells by + * stores the entire triangulation (as in, for example, step-18, + * subdomain ids are assigned to cells by * partitioning a mesh, and each MPI process then only works on those cells it * "owns", i.e. that belong to a subdomain that it is associated with * (traditionally, this is the case for the subdomain id whose numerical value diff --git a/deal.II/doc/doxygen/headers/multithreading.h b/deal.II/doc/doxygen/headers/multithreading.h index d671c516cd..b6c2e26f91 100644 --- a/deal.II/doc/doxygen/headers/multithreading.h +++ b/deal.II/doc/doxygen/headers/multithreading.h @@ -34,16 +34,16 @@ * namespace. The MultithreadInfo class allows to query certain * properties of the system, such as the number of CPUs. These * facilities for %parallel computing are described in the - * following. The step-9, step-13, step-14, step-32, step-35 and - * step-37 tutorial programs also show their use in practice, with the - * ones starting with step-32 using a more modern style of doing + * following. The step-9, step-13, step-14, and step-35 + * tutorial programs also show their use in practice, with the + * ones starting with step-35 using a more modern style of doing * things in which essentially we describe what can be done in * %parallel, while the older tutorial programs describe how * things have to be done in %parallel. * * On the other hand, programs running on distributed memory machines * (i.e. clusters) need a different programming model built on top of MPI and - * PETSc or Trilinos. This is described in the step-17, step-18 and step-32 + * PETSc or Trilinos. This is described in the step-17, and step-18 * example programs. * * @anchor MTToC @@ -1043,8 +1043,8 @@ * in at the positions indicated by _1, _2 and _3. * * To see the WorkStream class used in practice on tasks like the ones - * outlined above, take a look at the step-32, step-35 or step-37 - * tutorial programs. + * outlined above, take a look at the step-35 + * tutorial program. * * * @anchor MTThreads @@ -1120,7 +1120,7 @@ // In the program, before any task-based parallelism is reached. // Early in the main method is a good place to call this: - tbb::task_scheduler_init init(n_desired_threads + 1); + tbb::task_scheduler_init init(n_desired_threads + 1); * @endcode * The method of setting the number of threads relies on this call to * task_scheduler_init occurring before any other calls to the diff --git a/deal.II/doc/doxygen/headers/software.h b/deal.II/doc/doxygen/headers/software.h index 47822900b1..43098d2552 100644 --- a/deal.II/doc/doxygen/headers/software.h +++ b/deal.II/doc/doxygen/headers/software.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2005, 2006, 2007, 2008, 2009 by the deal.II authors +// Copyright (C) 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -117,7 +117,7 @@ * Interfaces to Trilinos exist in the TrilinosWrappers namespace, * making matrices, vectors, and solvers look like the corresponding * deal.II classes. Their use is explained in the @ref step_31 - * "step-31", step-32, and step-33 + * "step-31", and step-33 * tutorial programs. The PETSc and Trilinos * ReadMe file explains how to configure deal.II to use this diff --git a/deal.II/examples/step-16/doc/results.dox b/deal.II/examples/step-16/doc/results.dox index 762f8091b4..e995f32cd9 100644 --- a/deal.II/examples/step-16/doc/results.dox +++ b/deal.II/examples/step-16/doc/results.dox @@ -86,7 +86,7 @@ for second order problems.

    Possible extensions

    A close inspection of this program's performance shows that it is mostly -dominated by matrix-vector operations. step-37 shows one way +dominated by matrix-vector operations. The future step 37 will show one way how this can be avoided by working with matrix-free methods. Another avenue would be to use algebraic multigrid methods. The diff --git a/deal.II/examples/step-31/doc/intro.dox b/deal.II/examples/step-31/doc/intro.dox index 792ff9cc60..426eeb414e 100644 --- a/deal.II/examples/step-31/doc/intro.dox +++ b/deal.II/examples/step-31/doc/intro.dox @@ -54,8 +54,7 @@ The forcing term of the fluid motion is the buoyancy of the fluid, expressed as the product of the density $\rho$, the thermal expansion coefficient $\beta$, the temperature T and the gravity vector g pointing -downward. (A derivation of why the right hand side looks like it looks -is given in the introduction of step-32.) +downward. While the first two equations describe how the fluid reacts to temperature differences by moving around, the third equation states how the fluid motion affects the temperature field: it is an advection @@ -962,7 +961,7 @@ the latter class, one of the most interesting capabilities is the existence of the Trilinos ML package that implements an Algebraic Multigrid (AMG) method. We will use this preconditioner to precondition the second order operator part of the momentum equation. The ability to solve problems in -%parallel will be explored in step-32, using the same problem as +%parallel will be explored in a future step 32, using the same problem as discussed here. diff --git a/deal.II/examples/step-31/doc/results.dox b/deal.II/examples/step-31/doc/results.dox index 5f44a5db92..58432cac0d 100644 --- a/deal.II/examples/step-31/doc/results.dox +++ b/deal.II/examples/step-31/doc/results.dox @@ -344,7 +344,7 @@ $c_R=\left(2^{1/d}\right)^{4-2\alpha}=2^{\frac{4-2\alpha}{d}}$. Since this value for $c_R$ appears to work just fine for the current program, we corrected the formula in the program and set $c_R$ to a value that reproduces exactly the results we had before. We will, -however, revisit this issue again in step-32. +however, revisit this issue again in a future step 32. Now, however, back to the discussion of what values of $c_k$ and $\beta$ to choose: @@ -587,7 +587,7 @@ despite the penalty we pay in terms of smaller time steps. There are various ways to extend the current program. Of particular interest is, of course, to make it faster and/or increase the resolution of the -program, in particular in 3d. This is the topic of the step-32 +program, in particular in 3d. This is the topic of the future step 32 tutorial program which will implement strategies to solve this problem in %parallel on a cluster. diff --git a/deal.II/examples/step-35/step-35.cc b/deal.II/examples/step-35/step-35.cc index 4554dcf0b8..dfc08f0621 100644 --- a/deal.II/examples/step-35/step-35.cc +++ b/deal.II/examples/step-35/step-35.cc @@ -1,7 +1,7 @@ /* $Id$ */ /* Version: $Name: $ */ /* */ -/* Copyright (C) 2007, 2008, 2009 by the deal.II authors */ +/* Copyright (C) 2007, 2008, 2009, 2010 by the deal.II authors */ /* Author: Abner Salgado, Texas A&M University 2009 */ /* */ /* This file is subject to QPL and may not be distributed */ @@ -1369,8 +1369,8 @@ NavierStokesProjection::update_pressure (const bool reinit_prec) // graphical output. // // We will not elaborate on this process - // here, but rather refer to step-31 and - // step-32, where a similar procedure is used + // here, but rather refer to step-31, + // where a similar procedure is used // (and is documented) to create a joint // DoFHandler object for all variables. // diff --git a/deal.II/lac/include/lac/block_sparsity_pattern.h b/deal.II/lac/include/lac/block_sparsity_pattern.h index 4967802bc9..c35efa1822 100644 --- a/deal.II/lac/include/lac/block_sparsity_pattern.h +++ b/deal.II/lac/include/lac/block_sparsity_pattern.h @@ -954,8 +954,6 @@ class BlockCompressedSimpleSparsityPattern : public BlockSparsityPatternBase * * In this case, one possibility is to distribute local entries to the final @@ -374,7 +374,7 @@ class ConstraintMatrix : public Subscriptor * filter. Constrained dofs are * transformed to local index space of * the filter, and elements not present - * in the IndexSet are ignored. + * in the IndexSet are ignored. * * This function provides an easy way to * create a ConstraintMatrix for certain @@ -467,7 +467,7 @@ class ConstraintMatrix : public Subscriptor * set_inhomogeneity(). */ void add_lines (const IndexSet &lines); - + /** * Add an entry to a given * line. The list of lines is @@ -1336,7 +1336,7 @@ class ConstraintMatrix : public Subscriptor * Does the same as the function above * but can treat * non quadratic matrices. - */ + */ template void distribute_local_to_global (const FullMatrix &local_matrix, diff --git a/deal.II/lac/include/lac/petsc_parallel_vector.h b/deal.II/lac/include/lac/petsc_parallel_vector.h index bfec7d151a..3e20ad6ffb 100644 --- a/deal.II/lac/include/lac/petsc_parallel_vector.h +++ b/deal.II/lac/include/lac/petsc_parallel_vector.h @@ -47,7 +47,7 @@ namespace PETScWrappers */ namespace MPI { - + /** * Implementation of a parallel vector class based on PETSC and using MPI * communication to synchronise distributed operations. All the functionality @@ -159,7 +159,7 @@ namespace PETScWrappers * vector as empty. */ Vector (); - + /** * Constructor. Set dimension to * @p n and initialize all @@ -173,7 +173,7 @@ namespace PETScWrappers * communicator over which the * different parts of the vector * shall communicate - * + * * The constructor is made explicit * to avoid accidents like this: * v=0;. Presumably, the user @@ -187,14 +187,14 @@ namespace PETScWrappers explicit Vector (const MPI_Comm &communicator, const unsigned int n, const unsigned int local_size); - - + + /** * Copy-constructor from deal.II * vectors. Sets the dimension to that * of the given vector, and copies all * elements. - * + * * @arg local_size denotes the size * of the chunk that shall be stored * on the present process. @@ -209,12 +209,12 @@ namespace PETScWrappers const dealii::Vector &v, const unsigned int local_size); - + /** * Copy-constructor the * values from a PETSc wrapper vector * class. - * + * * @arg local_size denotes the size * of the chunk that shall be stored * on the present process. @@ -245,13 +245,13 @@ namespace PETScWrappers * ignored during construction. That * way, the ghost parameter can equal * the set of locally relevant - * degrees of freedom, see step-32. + * degrees of freedom. */ explicit Vector (const MPI_Comm &communicator, const IndexSet & local, const IndexSet & ghost = IndexSet(0)); - - + + /** * Copy the given vector. Resize the * present vector if necessary. Also @@ -260,7 +260,7 @@ namespace PETScWrappers */ Vector & operator = (const Vector &v); - + /** * Copy the given sequential * (non-distributed) vector @@ -347,17 +347,17 @@ namespace PETScWrappers * @p communicator denotes the MPI * communicator henceforth to be used * for this vector. - * + * * If @p fast is false, the vector * is filled by zeros. Otherwise, the * elements are left an unspecified * state. - */ + */ void reinit (const MPI_Comm &communicator, const unsigned int N, const unsigned int local_size, const bool fast = false); - + /** * Change the dimension to that of * the vector @p v, and also take @@ -384,7 +384,7 @@ namespace PETScWrappers const IndexSet & local, const IndexSet & ghost = IndexSet(0)); - + /** * Return a reference to the MPI * communicator object in use with @@ -418,7 +418,7 @@ namespace PETScWrappers virtual void create_vector (const unsigned int n, const unsigned int local_size, const IndexSet & ghostnodes); - + private: /** @@ -461,8 +461,8 @@ namespace PETScWrappers *this = v; } - - + + inline Vector & Vector::operator = (const PetscScalar s) @@ -471,7 +471,7 @@ namespace PETScWrappers return *this; } - + inline @@ -482,10 +482,10 @@ namespace PETScWrappers // then first resize the present one if (size() != v.size()) reinit (v.communicator, v.size(), v.local_size(), true); - + const int ierr = VecCopy (v.vector, vector); AssertThrow (ierr == 0, ExcPETScError(ierr)); - + return *this; } @@ -494,7 +494,7 @@ namespace PETScWrappers template inline Vector & - Vector::operator = (const dealii::Vector &v) + Vector::operator = (const dealii::Vector &v) { Assert (size() == v.size(), ExcDimensionMismatch (size(), v.size()));