From: turcksin Date: Fri, 1 Mar 2013 15:59:12 +0000 (+0000) Subject: Merge from mainline. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=ff81fa4ac621dd893de464b2a1478f9e9561be2d;p=dealii-svn.git Merge from mainline. git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@28689 0785d39b-7218-0410-832d-ea1e28bc413d --- ff81fa4ac621dd893de464b2a1478f9e9561be2d diff --cc deal.II/include/deal.II/dofs/dof_accessor.h index 03f0d9e59d,fd605cb43c..a7328c7cd7 --- a/deal.II/include/deal.II/dofs/dof_accessor.h +++ b/deal.II/include/deal.II/dofs/dof_accessor.h @@@ -368,77 -368,50 +368,50 @@@ public */ /** - * Return the indices of the dofs of this - * object in the standard ordering: dofs - * on vertex 0, dofs on vertex 1, etc, - * dofs on line 0, dofs on line 1, etc, - * dofs on quad 0, etc. + * Return the indices of the dofs of this object in the standard + * ordering: dofs on vertex 0, dofs on vertex 1, etc, dofs on line + * 0, dofs on line 1, etc, dofs on quad 0, etc. * - * The vector has to have the - * right size before being passed - * to this function. + * The vector has to have the right size before being passed to this + * function. * - * This function is most often - * used on active objects (edges, - * faces, cells). It can be used - * on non-active objects as well - * (i.e. objects that have - * children), but only if the - * finite element under - * consideration has degrees of - * freedom exclusively on - * vertices. Otherwise, the - * function doesn't make much - * sense, since for example - * inactive edges do not have - * degrees of freedom associated - * with them at all. + * @note The behavior descibed below for non-active cells will + * be removed in a future release. It is not very intuitive and its + * use is limited to FE_Q elements of degree 1. * - * The last argument denotes the - * finite element index. For the - * standard ::DoFHandler class, - * this value must be equal to - * its default value since that - * class only supports the same - * finite element on all cells - * anyway. + * This function is most often used on active objects (edges, faces, + * cells). It can be used on non-active objects as well + * (i.e. objects that have children), but only if the finite element + * under consideration has degrees of freedom exclusively on + * vertices. Otherwise, the function doesn't make much sense, since + * for example inactive edges do not have degrees of freedom + * associated with them at all. * - * However, for hp objects - * (i.e. the hp::DoFHandler - * class), different finite - * element objects may be used on - * different cells. On faces - * between two cells, as well as - * vertices, there may therefore - * be two sets of degrees of - * freedom, one for each of the - * finite elements used on the - * adjacent cells. In order to - * specify which set of degrees - * of freedom to work on, the - * last argument is used to - * disambiguate. Finally, if this - * function is called for a cell - * object, there can only be a - * single set of degrees of - * freedom, and fe_index has to - * match the result of + * The last argument denotes the finite element index. For the + * standard ::DoFHandler class, this value must be equal to its + * default value since that class only supports the same finite + * element on all cells anyway. + * + * However, for hp objects (i.e. the hp::DoFHandler class), + * different finite element objects may be used on different + * cells. On faces between two cells, as well as vertices, there may + * therefore be two sets of degrees of freedom, one for each of the + * finite elements used on the adjacent cells. In order to specify + * which set of degrees of freedom to work on, the last argument is + * used to disambiguate. Finally, if this function is called for a + * cell object, there can only be a single set of degrees of + * freedom, and fe_index has to match the result of * active_fe_index(). * - * For cells, there is only a - * single possible finite element - * index (namely the one for that - * cell, returned by - * cell-@>active_fe_index. Consequently, - * the derived DoFCellAccessor - * class has an overloaded - * version of this function that - * calls the present function - * with - * cell-@>active_fe_index - * as last argument. + * For cells, there is only a single possible finite element index + * (namely the one for that cell, returned by + * cell-@>active_fe_index. Consequently, the derived + * DoFCellAccessor class has an overloaded version of this function + * that calls the present function with + * cell-@>active_fe_index as last argument. + * */ - void get_dof_indices (std::vector &dof_indices, + void get_dof_indices (std::vector &dof_indices, const unsigned int fe_index = DH::default_fe_index) const; /** diff --cc deal.II/include/deal.II/grid/grid_generator.h index f899b62e7f,acabac7004..455129df0b --- a/deal.II/include/deal.II/grid/grid_generator.h +++ b/deal.II/include/deal.II/grid/grid_generator.h @@@ -704,10 -699,13 +704,13 @@@ public * (overwritten). * * In 1d, this function is not currently implemented. + * + * @deprecated This function has been moved to GridTools::laplace_transform */ template - static void laplace_transformation (Triangulation &tria, - const std::map > &new_points); + static + void laplace_transformation (Triangulation &tria, - const std::map > &new_points) DEAL_II_DEPRECATED; ++ const std::map > &new_points) DEAL_II_DEPRECATED; /** * Exception diff --cc deal.II/source/lac/petsc_matrix_base.cc index 283083724a,50962f17f4..0ddd19db0c --- a/deal.II/source/lac/petsc_matrix_base.cc +++ b/deal.II/source/lac/petsc_matrix_base.cc @@@ -262,7 -263,15 +262,15 @@@ namespace PETScWrapper - size_type + void + MatrixBase::compress () + { + compress(::dealii::VectorOperation::unknown); + } + + + - unsigned int ++ size_type MatrixBase::m () const { #ifdef PETSC_USE_64BIT_INDICES