]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
work on documentation and exception eliminated
authorkanschat <kanschat@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 22 Jun 2007 10:26:47 +0000 (10:26 +0000)
committerkanschat <kanschat@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 22 Jun 2007 10:26:47 +0000 (10:26 +0000)
git-svn-id: https://svn.dealii.org/trunk@14796 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/include/dofs/dof_constraints.h
deal.II/deal.II/include/dofs/dof_constraints.templates.h

index 9d815b535c0da6d983eeecbed007bf48ebc9987d..09abfb579610ced1ebecde96a92db983466fbc4e 100644 (file)
@@ -43,7 +43,7 @@ class BlockIndices;
  * $x_{i_1} = \sum_{j=2}^M a_{i_j} x_{i_j}$. In the context of adaptive finite
  * elements, such constraints appear most frequently as "hanging nodes". For
  * example, when using Q1 and Q2 elements (i.e. using
- * FE_Q%<dim%>(1) and FE_Q%<dim%>(2)) on the two
+ * FE_Q&lt;dim&gt;(1) and FE_Q&lt;dim&gt;(2)) on the two
  * marked cells of the mesh
  *
  * @image html hp-refinement-simple.png
@@ -106,7 +106,7 @@ class BlockIndices;
  * constrained degrees of freedom is inefficient, and a bottleneck if there
  * are many constraints and matrices are full, i.e. especially for 3d and/or
  * higher order or hp finite elements. We therefore offer a second way of
- * building linear systems, using the add_entried_local_to_global() and
+ * building linear systems, using the add_entries_local_to_global() and
  * distribute_local_to_global() functions discussed below. The resulting
  * linear systems are equivalent to what one gets after calling the condense()
  * functions.
@@ -233,7 +233,7 @@ class BlockIndices;
  * pattern object. It not only adds a given entry, but also all entries that
  * we will have to write to if the current entry corresponds to a constrained
  * degree of freedom that will later be eliminated. Similarly, one can use the
- * distribute_local_to_global() functions to directly distributed entries in
+ * distribute_local_to_global() functions to directly distribute entries in
  * vectors and matrices when copying local contributions into a global matrix
  * or vector. These calls make a subsequent call to condense() unnecessary.
  *
@@ -247,7 +247,7 @@ class BlockIndices;
  * <h3>Distributing constraints</h3>
  * 
  * After solving the condensed system of equations, the solution vector has to
- * be redistributed. This is done by the two @p distribute function, one
+ * be redistributed. This is done by the two distribute() functions, one
  * working with two vectors, one working in-place. The operation of
  * distribution undoes the condensation process in some sense, but it should
  * be noted that it is not the inverse operation. Basically, distribution sets
@@ -637,7 +637,7 @@ class ConstraintMatrix : public Subscriptor
                                      * <tt>condensed</tt> is the
                                      * dimension of
                                      * <tt>uncondensed</tt> minus the
-                                     * number of constraint degrees
+                                     * number of constrained degrees
                                      * of freedom.
                                      */
     void condense (const SparsityPattern &uncondensed,
@@ -1061,12 +1061,6 @@ class ConstraintMatrix : public Subscriptor
                                      *
                                      * @ingroup Exceptions
                                      */
-    DeclException0 (ExcWrongDimension);
-                                    /**
-                                     * Exception
-                                     *
-                                     * @ingroup Exceptions
-                                     */
     DeclException4 (ExcEntryAlreadyExists,
                    int, int, double, double,
                    << "The entry for the indices " << arg1 << " and "
index 560102750826ce681e80a9e717d8cabb61ef50e8..6a88ad2b795ad5bd9798cafda184251a93b4273e 100644 (file)
@@ -41,7 +41,7 @@ ConstraintMatrix::condense (const SparseMatrix<number> &uncondensed,
   Assert (condensed.n() == condensed.m(),
          ExcNotQuadratic());
   Assert (condensed.n()+n_constraints() == uncondensed.n(),
-         ExcWrongDimension());
+         ExcDimensionMismatch(condensed.n()+n_constraints(), uncondensed.n()));
 
                                   // store for each line of the matrix
                                   // its new line number
@@ -454,7 +454,8 @@ ConstraintMatrix::condense (const VectorType &uncondensed,
 {
   Assert (sorted == true, ExcMatrixNotClosed());
   Assert (condensed.size()+n_constraints() == uncondensed.size(),
-         ExcWrongDimension());
+         ExcDimensionMismatch(condensed.size()+n_constraints(),
+                              uncondensed.size()));
   
                                   // store for each line of the
                                   // vector its new line number after
@@ -562,7 +563,7 @@ distribute_local_to_global (const Vector<double>            &local_vector,
                             VectorType                      &global_vector) const
 {
   Assert (local_vector.size() == local_dof_indices.size(),
-          ExcWrongDimension());
+          ExcDimensionMismatch(local_vector.size(), local_dof_indices.size()));
   Assert (sorted == true, ExcMatrixNotClosed());
 
   const unsigned int n_local_dofs = local_vector.size();
@@ -640,9 +641,9 @@ distribute_local_to_global (const FullMatrix<double>        &local_matrix,
                             MatrixType                      &global_matrix) const
 {
   Assert (local_matrix.n() == local_dof_indices.size(),
-          ExcWrongDimension());
+          ExcDimensionMismatch(local_matrix.n(), local_dof_indices.size()));
   Assert (local_matrix.m() == local_dof_indices.size(),
-          ExcWrongDimension());
+          ExcDimensionMismatch(local_matrix.m(), local_dof_indices.size()));
   Assert (sorted == true, ExcMatrixNotClosed());
 
   const unsigned int n_local_dofs = local_dof_indices.size();
@@ -937,7 +938,8 @@ ConstraintMatrix::distribute (const VectorType &condensed,
 {
   Assert (sorted == true, ExcMatrixNotClosed());
   Assert (condensed.size()+n_constraints() == uncondensed.size(),
-         ExcWrongDimension());
+         ExcDimensionMismatch(condensed.size()+n_constraints(),
+                              uncondensed.size()));
 
                                   // store for each line of the new vector
                                   // its old line number before

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.