]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
merge from mainline
authorheister <heister@0785d39b-7218-0410-832d-ea1e28bc413d>
Sun, 17 Feb 2013 14:35:08 +0000 (14:35 +0000)
committerheister <heister@0785d39b-7218-0410-832d-ea1e28bc413d>
Sun, 17 Feb 2013 14:35:08 +0000 (14:35 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_unify_linear_algebra@28440 0785d39b-7218-0410-832d-ea1e28bc413d

50 files changed:
1  2 
deal.II/examples/step-18/step-18.cc
deal.II/examples/step-32/step-32.cc
deal.II/examples/step-35/step-35.cc
deal.II/examples/step-40/step-40.cc
deal.II/examples/step-42/step-42.cc
deal.II/examples/step-47/step-47.cc
deal.II/include/deal.II/base/exceptions.h
deal.II/include/deal.II/base/smartpointer.h
deal.II/include/deal.II/base/utilities.h
deal.II/include/deal.II/dofs/dof_tools.h
deal.II/include/deal.II/fe/fe_poly_tensor.h
deal.II/include/deal.II/fe/mapping_q1_eulerian.h
deal.II/include/deal.II/fe/mapping_q_eulerian.h
deal.II/include/deal.II/grid/grid_generator.h
deal.II/include/deal.II/grid/grid_in.h
deal.II/include/deal.II/grid/tria_boundary.h
deal.II/include/deal.II/lac/block_matrix_base.h
deal.II/include/deal.II/lac/chunk_sparse_matrix.h
deal.II/include/deal.II/lac/chunk_sparse_matrix.templates.h
deal.II/include/deal.II/lac/compressed_simple_sparsity_pattern.h
deal.II/include/deal.II/lac/constraint_matrix.templates.h
deal.II/include/deal.II/lac/parallel_vector.h
deal.II/include/deal.II/lac/petsc_parallel_vector.h
deal.II/include/deal.II/lac/petsc_vector_base.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/trilinos_vector.h
deal.II/include/deal.II/lac/trilinos_vector_base.h
deal.II/include/deal.II/matrix_free/matrix_free.h
deal.II/include/deal.II/numerics/matrix_tools.h
deal.II/include/deal.II/numerics/vector_tools.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/mapping_q1.cc
deal.II/source/grid/grid_generator.cc
deal.II/source/grid/grid_tools.cc
deal.II/source/lac/constraint_matrix.cc
deal.II/source/lac/petsc_matrix_free.cc
deal.II/source/lac/petsc_parallel_vector.cc
deal.II/source/lac/petsc_solver.cc
deal.II/source/lac/petsc_vector_base.cc
deal.II/source/lac/slepc_solver.cc
deal.II/source/lac/sparse_direct.cc
deal.II/source/lac/trilinos_sparse_matrix.cc
deal.II/source/lac/trilinos_sparsity_pattern.cc
deal.II/source/numerics/derivative_approximation.cc
deal.II/source/numerics/error_estimator.cc
deal.II/source/numerics/matrix_tools.cc

Simple merge
Simple merge
Simple merge
index 25994894d5b06426054ed93ce8febd0339234ef6,3529e209f9ed09901797c34c3f55b4b935c6eea4..4fce77cb121d28c05f3f18143ad2fa5a78ff6966
@@@ -248,10 -233,9 +248,9 @@@ namespace Step4
      locally_relevant_solution.reinit (mpi_communicator,
                                        locally_owned_dofs,
                                        locally_relevant_dofs);
-     locally_relevant_solution = 0;
      system_rhs.reinit (mpi_communicator,
 -                       dof_handler.n_dofs(),
 -                       dof_handler.n_locally_owned_dofs());
 +                       locally_owned_dofs);
 +
      system_rhs = 0;
  
      // The next step is to compute hanging node and boundary value
Simple merge
Simple merge
index d3b955ed27a5a1337b38fffca3d2b8eaa283fa09,b92327f0bfea56b7522cb265880fa3042bfb3603..0deceace4bbd81cd87ac7a3bad8d3fe66ffed47b
@@@ -69,52 -62,32 +62,32 @@@ public
     *
     * @image html hyper_cubes.png
     *
-    * See also
-    * subdivided_hyper_cube() for a
-    * coarse mesh consisting of
-    * several cells. See
-    * hyper_rectangle(), if
-    * different lengths in different
-    * ordinate directions are
-    * required.
-    *
-    * @note The triangulation needs to be
-    * void upon calling this
-    * function.
+    * See also subdivided_hyper_cube() for a coarse mesh consisting of several
+    * cells. See hyper_rectangle(), if different lengths in different ordinate
+    * directions are required.
+    *
+    * @note The triangulation needs to be void upon calling this function.
     */
    template <int dim, int spacedim>
 -  static void hyper_cube (Triangulation<dim,spacedim> &tria,
 +  static void hyper_cube (Triangulation<dim,spacedim>  &tria,
                            const double        left = 0.,
                            const double        right= 1.);
  
    /**
-    * Same as hyper_cube(), but
-    * with the difference that not
-    * only one cell is created but
-    * each coordinate direction is
-    * subdivided into
-    * @p repetitions cells. Thus,
-    * the number of cells filling
-    * the given volume is
+    * Same as hyper_cube(), but with the difference that not only one cell is
+    * created but each coordinate direction is subdivided into @p repetitions
+    * cells. Thus, the number of cells filling the given volume is
     * <tt>repetitions<sup>dim</sup></tt>.
     *
-    * If spacedim=dim+1 the same
-    * mesh as in the case
-    * spacedim=dim is created, but
-    * the vertices have an
-    * additional coordinate =0. So,
-    * if dim=1 one obtains line
-    * along the x axis in the xy
-    * plane, and if dim=3 one
-    * obtains a square in lying in
-    * the xy plane in 3d space.
-    *
-    * @note The triangulation needs
-    * to be void upon calling this
-    * function.
+    * If spacedim=dim+1 the same mesh as in the case spacedim=dim is created,
+    * but the vertices have an additional coordinate =0. So, if dim=1 one
+    * obtains line along the x axis in the xy plane, and if dim=3 one obtains a
+    * square in lying in the xy plane in 3d space.
+    *
+    * @note The triangulation needs to be void upon calling this function.
     */
    template <int dim>
 -  static void subdivided_hyper_cube (Triangulation<dim> &tria,
 +  static void subdivided_hyper_cube (Triangulation<dim>  &tria,
                                       const unsigned int  repetitions,
                                       const double        left = 0.,
                                       const double        right= 1.);
    template <int dim>
    static
    void
 -  parallelogram(Triangulation<dim> &tria,
 +  parallelogram(Triangulation<dim>  &tria,
-               const Point<dim> (&corners)[dim],
-               const bool           colorize=false);
+                 const Point<dim> (&corners)[dim],
+                 const bool           colorize=false);
  
  
    /**
index 37096c1657e6ae929564703c9977f672baf9f90a,ffbdd2598660b71783088dc8f764dac992d47ddd..bb549a72c8c784b014cfd2bb7e54d805a1b881e9
@@@ -508,9 -525,9 +525,11 @@@ namespace PETScWrapper
  
        const int ierr = VecCopy (v.vector, vector);
        AssertThrow (ierr == 0, ExcPETScError(ierr));
 -
 +      if (ghosted)
 +      update_ghost_values();
 +      
+       if (has_ghost_elements())
+         update_ghost_values();
        return *this;
      }
  
Simple merge
Simple merge
Simple merge
Simple merge
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.