]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
merge from mainline
authorheister <heister@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 7 Jan 2013 16:06:49 +0000 (16:06 +0000)
committerheister <heister@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 7 Jan 2013 16:06:49 +0000 (16:06 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_unify_linear_algebra@27963 0785d39b-7218-0410-832d-ea1e28bc413d

42 files changed:
1  2 
deal.II/examples/step-37/step-37.cc
deal.II/examples/step-6/step-6.cc
deal.II/include/deal.II/base/utilities.h
deal.II/include/deal.II/dofs/dof_handler_policy.h
deal.II/include/deal.II/dofs/dof_renumbering.h
deal.II/include/deal.II/dofs/dof_tools.h
deal.II/include/deal.II/fe/mapping_q_eulerian.h
deal.II/include/deal.II/grid/grid_tools.h
deal.II/include/deal.II/hp/fe_values.h
deal.II/include/deal.II/lac/parallel_vector.h
deal.II/include/deal.II/lac/petsc_matrix_base.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/sparsity_pattern.h
deal.II/include/deal.II/lac/trilinos_block_vector.h
deal.II/include/deal.II/lac/trilinos_parallel_block_vector.h
deal.II/include/deal.II/lac/trilinos_vector_base.h
deal.II/include/deal.II/lac/vector.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/matrix_free/mapping_info.h
deal.II/include/deal.II/matrix_free/matrix_free.h
deal.II/include/deal.II/multigrid/mg_tools.h
deal.II/include/deal.II/numerics/error_estimator.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/fe_system.cc
deal.II/source/fe/mapping_q1_eulerian.cc
deal.II/source/grid/grid_generator.cc
deal.II/source/grid/grid_tools.cc
deal.II/source/grid/tria.cc
deal.II/source/hp/fe_values.cc
deal.II/source/lac/petsc_parallel_vector.cc
deal.II/source/lac/petsc_vector_base.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/error_estimator.cc
deal.II/source/numerics/matrix_tools.cc

index 0da8d2474f7932c65430e9c0597ff49701d35e21,fb8834e003f48adba066ac52758cf22a2895c5b6..fcd628917a99a9767eb3eab4190a7037ad55bcc8
@@@ -273,9 -272,9 +272,9 @@@ namespace Step3
  
      void clear();
  
-     void reinit (const MGDoFHandler<dim> &dof_handler,
+     void reinit (const DoFHandler<dim>  &dof_handler,
 -                 const ConstraintMatrix &constraints,
 +                 const ConstraintMatrix  &constraints,
-                  const unsigned int       level = numbers::invalid_unsigned_int);
+                  const unsigned int      level = numbers::invalid_unsigned_int);
  
      unsigned int m () const;
      unsigned int n () const;
    // FEEvaluation class (and its template arguments) will be explained below.
    template <int dim, int fe_degree, typename number>
    void
-   LaplaceOperator<dim,fe_degree,number>::reinit (const MGDoFHandler<dim> &dof_handler,
+   LaplaceOperator<dim,fe_degree,number>::reinit (const DoFHandler<dim>  &dof_handler,
 -                                                 const ConstraintMatrix &constraints,
 +                                                 const ConstraintMatrix  &constraints,
                                                   const unsigned int      level)
    {
      typename MatrixFree<dim,number>::AdditionalData additional_data;
Simple merge
Simple merge
index bfd47e83c0c925cbc4999d87480be2c7f208246b,481fe26814a1c480f59f83757a7634e5febc4909..4eb7cab71131dbd24b0831da794632196b9710ed
@@@ -88,11 -79,10 +79,10 @@@ namespace interna
         */
        UpdateFlags
        compute_update_flags (const UpdateFlags                        update_flags,
 -                            const std::vector<dealii::hp::QCollection<1> > &quad) const;
 +                            const std::vector<dealii::hp::QCollection<1> >  &quad) const;
  
        /**
-        * Returns the type of a given cell as
-        * detected during initialization.
+        * Returns the type of a given cell as detected during initialization.
         */
        CellType get_cell_type (const unsigned int cell_chunk_no) const;
  
index 4cce7ed8887bf6ee7b7c9030da17562fd745fa27,e2d05f0fd34275c86f229412c3df09b1caf720bc..5876442e9de6c565cdd5916d432ad51f3666700a
@@@ -231,9 -231,9 +231,9 @@@ namespace MGTool
     */
    template <int dim, int spacedim>
    void
-   make_boundary_list (const MGDoFHandler<dim,spacedim>      &mg_dof,
+   make_boundary_list (const DoFHandler<dim,spacedim>      &mg_dof,
                        const typename FunctionMap<dim>::type &function_map,
 -                      std::vector<std::set<unsigned int> > &boundary_indices,
 +                      std::vector<std::set<unsigned int> >  &boundary_indices,
                        const ComponentMask                   &component_mask = ComponentMask());
  
    /**
     */
    template <int dim, int spacedim>
    void
-   extract_inner_interface_dofs (const MGDoFHandler<dim,spacedim> &mg_dof_handler,
+   extract_inner_interface_dofs (const DoFHandler<dim,spacedim> &mg_dof_handler,
 -                                std::vector<std::vector<bool> > &interface_dofs,
 -                                std::vector<std::vector<bool> > &boundary_interface_dofs);
 +                                std::vector<std::vector<bool> >  &interface_dofs,
 +                                std::vector<std::vector<bool> >  &boundary_interface_dofs);
  
    /**
     * Does the same as the function above,
     */
    template <int dim, int spacedim>
    void
-   extract_inner_interface_dofs (const MGDoFHandler<dim,spacedim> &mg_dof_handler,
+   extract_inner_interface_dofs (const DoFHandler<dim,spacedim> &mg_dof_handler,
 -                                std::vector<std::vector<bool> > &interface_dofs);
 +                                std::vector<std::vector<bool> >  &interface_dofs);
  
    template <int dim, int spacedim>
    void
-   extract_non_interface_dofs (const MGDoFHandler<dim,spacedim> &mg_dof_handler,
+   extract_non_interface_dofs (const DoFHandler<dim,spacedim> &mg_dof_handler,
 -                              std::vector<std::set<unsigned int> > &non_interface_dofs);
 +                              std::vector<std::set<unsigned int> >  &non_interface_dofs);
  }
  
  /* @} */
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.