]> https://gitweb.dealii.org/ - dealii.git/commitdiff
merge from mainline
authorTimo Heister <timo.heister@gmail.com>
Thu, 13 Dec 2012 23:30:31 +0000 (23:30 +0000)
committerTimo Heister <timo.heister@gmail.com>
Thu, 13 Dec 2012 23:30:31 +0000 (23:30 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_unify_linear_algebra@27817 0785d39b-7218-0410-832d-ea1e28bc413d

23 files changed:
1  2 
deal.II/examples/step-46/step-46.cc
deal.II/examples/step-6/step-6.cc
deal.II/include/deal.II/base/geometry_info.h
deal.II/include/deal.II/base/utilities.h
deal.II/include/deal.II/dofs/dof_tools.h
deal.II/include/deal.II/grid/grid_tools.h
deal.II/include/deal.II/lac/chunk_sparse_matrix.h
deal.II/include/deal.II/lac/constraint_matrix.h
deal.II/include/deal.II/lac/constraint_matrix.templates.h
deal.II/include/deal.II/lac/petsc_solver.h
deal.II/include/deal.II/lac/sparse_matrix.h
deal.II/include/deal.II/lac/sparse_matrix.templates.h
deal.II/include/deal.II/lac/sparsity_pattern.h
deal.II/include/deal.II/lac/vector.templates.h
deal.II/include/deal.II/matrix_free/fe_evaluation.h
deal.II/include/deal.II/numerics/vector_tools.templates.h
deal.II/source/dofs/dof_handler_policy.cc
deal.II/source/dofs/dof_tools.cc
deal.II/source/fe/fe_system.cc
deal.II/source/grid/grid_tools.cc
deal.II/source/lac/constraint_matrix.cc
deal.II/source/lac/petsc_solver.cc
deal.II/source/lac/trilinos_sparse_matrix.cc

Simple merge
index 3708b7c48248c1dc18e45cc9979755622d18655f,068fe9a410effadb4a509dfca3e4b7b34b6ba630..11e9f79ee49ed208da97f5aca1d9c0b818775675
@@@ -444,16 -430,10 +444,16 @@@ void Step6<dim>::assemble_system (
        // @p cell_rhs into the global objects.
        cell->get_dof_indices (local_dof_indices);
        constraints.distribute_local_to_global(cell_matrix,
-                                            cell_rhs,
-                                            local_dof_indices,
-                                            system_matrix, system_rhs);
+                                              cell_rhs,
+                                              local_dof_indices,
+                                              system_matrix, system_rhs);
      }
 +
 +#ifdef USE_PETSC_LA
 +  system_matrix.compress();
 +  system_rhs.compress();
 +#endif
 +
    // Now we are done assembling the linear system.  The constrained nodes are
    // still in the linear system (there is a one on the diagonal of the matrix
    // and all other entries for this line are set to zero) but the computed
index 2d77baf4b07cf90e345a5c6163670ade067765e9,9092530630d276188d6485fcd872cb3cc43cd90b..add3c011084623a5b5994703b42e44a6af36bb81
@@@ -610,24 -484,17 +484,17 @@@ public
    explicit SparseMatrix (const SparsityPattern &sparsity);
  
    /**
-    * Copy constructor: initialize
-    * the matrix with the identity
-    * matrix. This constructor will
-    * throw an exception if the
-    * sizes of the sparsity pattern
-    * and the identity matrix do not
-    * coincide, or if the sparsity
-    * pattern does not provide for
-    * nonzero entries on the entire
-    * diagonal.
+    * Copy constructor: initialize the matrix with the identity matrix. This
+    * constructor will throw an exception if the sizes of the sparsity pattern
+    * and the identity matrix do not coincide, or if the sparsity pattern does
+    * not provide for nonzero entries on the entire diagonal.
     */
    SparseMatrix (const SparsityPattern &sparsity,
 -                const IdentityMatrix &id);
 +                const IdentityMatrix  &id);
  
    /**
-    * Destructor. Free all memory, but do not
-    * release the memory of the sparsity
-    * structure.
+    * Destructor. Free all memory, but do not release the memory of the
+    * sparsity structure.
     */
    virtual ~SparseMatrix ();
  
    SparseMatrix<number> &operator = (const SparseMatrix<number> &);
  
    /**
-    * Copy operator: initialize
-    * the matrix with the identity
-    * matrix. This operator will
-    * throw an exception if the
-    * sizes of the sparsity pattern
-    * and the identity matrix do not
-    * coincide, or if the sparsity
-    * pattern does not provide for
-    * nonzero entries on the entire
-    * diagonal.
+    * Copy operator: initialize the matrix with the identity matrix. This
+    * operator will throw an exception if the sizes of the sparsity pattern and
+    * the identity matrix do not coincide, or if the sparsity pattern does not
+    * provide for nonzero entries on the entire diagonal.
     */
    SparseMatrix<number> &
 -  operator= (const IdentityMatrix &id);
 +  operator= (const IdentityMatrix  &id);
  
    /**
-    * This operator assigns a scalar to
-    * a matrix. Since this does usually
-    * not make much sense (should we set
-    * all matrix entries to this value?
-    * Only the nonzero entries of the
-    * sparsity pattern?), this operation
-    * is only allowed if the actual
-    * value to be assigned is zero. This
-    * operator only exists to allow for
-    * the obvious notation
-    * <tt>matrix=0</tt>, which sets all
-    * elements of the matrix to zero,
-    * but keep the sparsity pattern
+    * This operator assigns a scalar to a matrix. Since this does usually not
+    * make much sense (should we set all matrix entries to this value?  Only
+    * the nonzero entries of the sparsity pattern?), this operation is only
+    * allowed if the actual value to be assigned is zero. This operator only
+    * exists to allow for the obvious notation <tt>matrix=0</tt>, which sets
+    * all elements of the matrix to zero, but keep the sparsity pattern
     * previously used.
     */
    SparseMatrix &operator = (const double d);
index 0eb882880764b2fe639310ad2c8cf7dcbc7d89da,fe87da3f19aa9e2ca5ab68655ccd57e9bb229187..5c13c278e0a3e4d85157a750afcafc4e68f608a1
@@@ -496,46 -385,26 +385,26 @@@ public
    /**
     * Make a copy with extra off-diagonals.
     *
-    * This constructs objects intended for
-    * the application of the ILU(n)-method
-    * or other incomplete decompositions.
-    * Therefore, additional to the original
-    * entry structure, space for
-    * <tt>extra_off_diagonals</tt>
-    * side-diagonals is provided on both
-    * sides of the main diagonal.
-    *
-    * <tt>max_per_row</tt> is the
-    * maximum number of nonzero
-    * elements per row which this
-    * structure is to hold. It is
-    * assumed that this number is
-    * sufficiently large to
-    * accommodate both the elements
-    * in <tt>original</tt> as well
-    * as the new off-diagonal
-    * elements created by this
-    * constructor. You will usually
-    * want to give the same number
-    * as you gave for
-    * <tt>original</tt> plus the
-    * number of side diagonals times
-    * two. You may however give a
-    * larger value if you wish to
-    * add further nonzero entries
-    * for the decomposition based on
-    * other criteria than their
-    * being on side-diagonals.
-    *
-    * This function requires that
-    * <tt>original</tt> refers to a
-    * quadratic matrix structure.
-    * It must be compressed. The
-    * matrix structure is not
-    * compressed after this function
-    * finishes.
+    * This constructs objects intended for the application of the ILU(n)-method
+    * or other incomplete decompositions.  Therefore, additional to the
+    * original entry structure, space for <tt>extra_off_diagonals</tt>
+    * side-diagonals is provided on both sides of the main diagonal.
+    *
+    * <tt>max_per_row</tt> is the maximum number of nonzero elements per row
+    * which this structure is to hold. It is assumed that this number is
+    * sufficiently large to accommodate both the elements in <tt>original</tt>
+    * as well as the new off-diagonal elements created by this constructor. You
+    * will usually want to give the same number as you gave for
+    * <tt>original</tt> plus the number of side diagonals times two. You may
+    * however give a larger value if you wish to add further nonzero entries
+    * for the decomposition based on other criteria than their being on
+    * side-diagonals.
+    *
+    * This function requires that <tt>original</tt> refers to a quadratic
+    * matrix structure.  It must be compressed. The matrix structure is not
+    * compressed after this function finishes.
     */
 -  SparsityPattern (const SparsityPattern &original,
 +  SparsityPattern (const SparsityPattern  &original,
                     const unsigned int      max_per_row,
                     const unsigned int      extra_off_diagonals);
  
index 7310c51a8bbde284a4c08e71c59ceb3d08552613,619d4788148682a3eb4f0694edce35abc7f9c417..bf8ecfb8ec6abc60f71329f14150700627999b4a
@@@ -1947,28 -1781,26 +1781,26 @@@ namespace DoFTool
  
  
      void
 -    make_hp_hanging_node_constraints (const dealii::hp::DoFHandler<1> & /*dof_handler*/,
 -                                      ConstraintMatrix &        /*constraints*/)
 +    make_hp_hanging_node_constraints (const dealii::hp::DoFHandler<1> &/*dof_handler*/,
 +                                      ConstraintMatrix        &/*constraints*/)
      {
-       // we may have to compute
-       // constraints for
-       // vertices. gotta think about
+       // we may have to compute constraints for vertices. gotta think about
        // that a bit more
- //TODO[WB]: think about what to do here...
+       //TODO[WB]: think about what to do here...
      }
  
  
  
      void
 -    make_oldstyle_hanging_node_constraints (const dealii::hp::DoFHandler<1> & /*dof_handler*/,
 -                                            ConstraintMatrix &        /*constraints*/,
 +    make_oldstyle_hanging_node_constraints (const dealii::hp::DoFHandler<1> &/*dof_handler*/,
 +                                            ConstraintMatrix        &/*constraints*/,
                                              dealii::internal::int2type<1>)
      {
-       // we may have to compute
-       // constraints for
-       // vertices. gotta think about
+       // we may have to compute constraints for vertices. gotta think about
        // that a bit more
- //TODO[WB]: think about what to do here...
+       //TODO[WB]: think about what to do here...
      }
  
  
Simple merge
Simple merge
Simple merge

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.