From: Wolfgang Bangerth Date: Mon, 26 Sep 2016 20:38:33 +0000 (-0600) Subject: Move some changes from 'general changes' to 'specific improvements'. X-Git-Tag: v8.5.0-rc1~636^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=547634b42ecb908642f7431225c2d5b556a7fea8;p=dealii.git Move some changes from 'general changes' to 'specific improvements'. --- diff --git a/doc/news/changes.h b/doc/news/changes.h index 83964c945d..769e2bb193 100644 --- a/doc/news/changes.h +++ b/doc/news/changes.h @@ -207,40 +207,13 @@ inconvenience this causes.
    -
  1. New: DoFTools::write_gnuplot_dof_support_point_info outputs - support point locations and dof indices to a format readable by - gnuplot. -
    - (Timo Heister, 2016/09/16) -
  2. - -
  3. Fixed: The CMake macros DEAL_II_(ADD_TEST|SETUP_TARGET) - now enforce a stricter CMAKE_BUILD_TYPE handling. This helps - to avoid situations where targets with different build flavors might - accidentally get linked against each other. -
    - (Matthias Maier, 2016/09/08) -
  4. - -
  5. Improved: the doxygen documentation now contains nicely formatted +
  6. Improved: The doxygen documentation now contains nicely formatted boxes containing the text message of each exception. Several messages haven been clarified and improved.
    (Timo Heister, 2016/09/06)
  7. -
  8. Fixed: Reimplement copy_triangulation and load in - dealii::parallel::shared::Triangulation, this avoids the loss of - partition information which causes p::s::Triangulation to be in an invalid state. -
    - (Ce Qin, 2016/09/05) -
  9. - -
  10. Fixed: The build system now uses -fPIC instead of -fpic -
    - (Matthias Maier, 2016/08/31) -
  11. -
  12. New: There are 6 new video lectures that explain the basics of Linux and the command line, how mesh refinement works, and some more complicated time stepping schemes. @@ -249,15 +222,6 @@ inconvenience this causes. (Wolfgang Bangerth, 2016/08/19)
  13. -
  14. New: It is now possible to generate a cell_iterator to a cell - that is identified by a CellId. CellIds are unique even across - processes in distributed computations, therefore this change allows - to identify a particular cell (e.g. a ghost cell of the local process) in - another domain. -
    - (Rene Gassmoeller, 2016/08/17) -
  15. -
  16. New: deal.II no longer uses features of the C++ language that were deprecated with C++11, C++14, or that are scheduled to be deprecated for C++17. @@ -265,20 +229,6 @@ inconvenience this causes. (David Wells, Jonathan Robey, Wolfgang Bangerth, 2016/08/11)
  17. -
  18. New: Introduce operators for residuals and interior penalty terms for - the Grad-Div operator in LocalIntegrators::GradDiv. -
    - (Timo Heister, Guido Kanschat, 2016/08/02) -
  19. - -
  20. - New: Added a new PolarManifold descriptor, that uses a polar coordinate - system to compute new points, and modified the existing SphericalManifold - descriptor to use geodesics on the surface of the sphere. -
    - (Luca Heltai, Mauro Bardelloni, 2016/08/04) -
  21. -
  22. New: Added Python bindings to generate and manipulate a Triangulation from Python. The Triangulation generated in Python can be saved and later, loaded @@ -294,34 +244,6 @@ inconvenience this causes. (David Wells, 2016/07/25)
  23. -
  24. - Improved: VectorTools::interpolate() may now be used on FESystems with mixed - interpolating and non-interpolating FEs, if all of the selected components for - interpolation originate from interpolating FEs. -
    - (Jonathan Robey, 2016/07/24) -
  25. - -
  26. - Improved: VectorTools::interpolate() now takes a ComponentMask to select the - components to interpolate. -
    - (Jonathan Robey, 2016/07/21) -
  27. - -
  28. Improved: Split out pattern descriptions for LaTeX and Description - ParameterHandler OutputStyles, and add better description text. -
    - (Jonathan Robey, 2016/07/21) -
  29. - -
  30. New: Added GridGenerator::quarter_hyper_ball() to generate the - intersection of a hyper ball with the positive orthant relative - to its center. -
    - (Daniel Arndt, 2016/07/19) -
  31. -
  32. Improved: The build system now checks for usable compiler/linker flags during various stages of the configure run. This should catch the majority of issues by user supplied flags/libraries and unusable final @@ -352,22 +274,6 @@ inconvenience this causes. (Matthias Maier, Timo Heister, 2016/07/06)
  33. -
  34. New: Added TrilinosWrappers::SolveDirect::Initialize and - TrilinosWrappers::SolverDirect::Solve to solve distributed linear systems - with multiple right hand sides without needing to refactorize the matrix - everytime. Also, added unit test for testing the new functionality. -
    - (Michael Harmon, 2016/06/30) -
  35. - -
  36. Changed: Similar to MappingQEulerian, MappingQ1Eulerian has gained - a second constructor that reverses the order of the arguments to indicate - which DoFHandler a vector is based on. The old constructor is now - deprecated and will be removed in a future version. -
    - (Wolfgang Bangerth, 2016/06/25) -
  37. -
  38. New: Add new classes to expand a scalar finite element solution into the orthogonal bases FESeries::Fourier and FESeries::Legendre. Also provide auxiliary functions to calculate norms of subsets of expansion @@ -397,28 +303,6 @@ inconvenience this causes. (Jean-Paul Pelteret, 2016/05/20)
  39. -
  40. New: Add VectorTools::compute_global_error that computes global - errors from cellwise errors obtained by VectorTools::integrate_difference() - and do MPI collectives if necessary. -
    - (Timo Heister, 2016/05/15) -
  41. - -
  42. New: Add functions to transform Cartesian coordinates to spherical and back: - GeometricUtilities::Coordinates::to_spherical and - GeometricUtilities::Coordinates::from_spherical. -
    - (Denis Davydov, 2016/05/10) -
  43. - -
  44. Improved: The method Triangulation::create_triangulation will now throw an - exception if any cells have negative measure. This check is not run if the - triangulation keeps track of distorted cells or if the codimension is not zero. - This check was previously only run in 3D. -
    - (David Wells, 2016/05/07) -
  45. -
  46. New: Add a collection of classes to manage user's quadrature point data: CellDataStorage, TransferableQuadraturePointData and parallel::distributed::ContinuousQuadratureDataTransfer. @@ -436,7 +320,6 @@ inconvenience this causes. (Denis Davydov, 2016/04/28)
  47. -
  48. New: Added move operations to BlockIndices, BlockVectorBase and BlockVector; Vector move operations nullify old object instead of using swap. @@ -444,23 +327,6 @@ inconvenience this causes. (Daniel Shapero, 2016/04/13)
  49. -
  50. New: Added TensorProductManifold to create new manifolds from two - ChartManifold objects. This can be used, for example, to combine a - 2d manifold with a flat manifold for an extruded mesh. -
    - (Timo Heister, 2016/04/12) -
  51. - -
  52. New: Added New option in the read_ucd function of the GridIn class. - A flag can now be assigned to the function, to decide wether the - indicators specified in a UCD file should be interpreted as - boundary_ids or as manifold_ids. This is particularly useful - when the indicators refer to internal faces, for which - boundary_ids cannot be used. -
    - (Andrea Mola, 2016/04/11) -
  53. -
  54. New: Manifold objects were previously only used to compute the locations of individual new points on a manifold. Now, they are also used to compute tangent vectors (via Manifold::get_tangent_vector()), and this @@ -476,13 +342,6 @@ inconvenience this causes. (Luca Heltai, Wolfgang Bangerth, 2016/04/08)
  55. -
  56. New: Added CompositionManifold to create new manifolds from two - ChartManifold objects. This can be used, for example, to rotate a - cylindrical Manifold, or to make a cylinders with parabolic sides. -
    - (Luca Heltai, 2016/04/09) -
  57. -
  58. New: Added a new Mapping class, MappingManifold, to use exact geometrical information extracted from the Manifold description instead of a polynomial approximation when computing transformations from the @@ -495,28 +354,6 @@ inconvenience this causes. (Luca Heltai, 2016/04/09)
  59. -
  60. New: Added GridGenerator::torus() to generate the volume mesh of a - torus in three dimensions and a manifold description TorusManifold to - go with it. -
    - (Timo Heister, 2016/03/21) -
  61. - -
  62. New: Added GridTools::rotate() in three space dimensions. -
    - (Timo Heister, 2016/03/18) -
  63. - -
  64. New: Added unit tests for complex-valued PETSc and SLEPc. -
    - (Toby D. Young, Denis Davydov, 2016/03/11) -
  65. - -
  66. New: Added another scaling factor to Kelly error estimator, namely h_K. -
    - (Denis Davydov, 2016/03/05) -
  67. -
  68. New: Added indent target to indent all headers and source files. Now you can do make (or ninja) indent inside the build directory. @@ -539,6 +376,13 @@ inconvenience this causes. (Jonathan Robey, 2016/09/21)
  69. +
  70. New: DoFTools::write_gnuplot_dof_support_point_info outputs + support point locations and dof indices to a format readable by + gnuplot. +
    + (Timo Heister, 2016/09/16) +
  71. +
  72. Fixed: EmbeddedRungeKutta methods now correctly increase delta_t_guess when the error is below coarsen_tol.
    @@ -589,11 +433,32 @@ inconvenience this causes.
    (Daniel Arndt, 2016/09/11)
  73. + +
  74. Fixed: The CMake macros DEAL_II_(ADD_TEST|SETUP_TARGET) + now enforce a stricter CMAKE_BUILD_TYPE handling. This helps + to avoid situations where targets with different build flavors might + accidentally get linked against each other. +
    + (Matthias Maier, 2016/09/08) +
  75. +
  76. Fixed: FE_TraceQ now provides unit support points.
    (Martin Kronbichler, 2016/09/08)
  77. +
  78. Fixed: Reimplement copy_triangulation and load in + dealii::parallel::shared::Triangulation, this avoids the loss of + partition information which causes parallel::shared::Triangulation to be in an invalid state. +
    + (Ce Qin, 2016/09/05) +
  79. + +
  80. Fixed: The build system now uses -fPIC instead of -fpic +
    + (Matthias Maier, 2016/08/31) +
  81. +
  82. Fixed: Fix MPI_InitFinalize by correctly initializing and destroying all p4est/libsc related objects by calls to sc_init(), p4est_init(), and sc_finalize(); compatibility with p4est versions >1.1. @@ -616,6 +481,15 @@ inconvenience this causes. (Rene Gassmoeller, Juliane Dannberg, 2016/08/24)
  83. +
  84. New: It is now possible to generate a cell_iterator to a cell + that is identified by a CellId. CellIds are unique even across + processes in distributed computations, therefore this change allows + to identify a particular cell (e.g. a ghost cell of the local process) in + another domain. +
    + (Rene Gassmoeller, 2016/08/17) +
  85. +
  86. New: Rank-4 symmetric tensors of type SymmetricTensor can now be converted to rank-4 tensors of type Tensor.
    @@ -639,6 +513,14 @@ inconvenience this causes. (Timo Heister, Guido Kanschat, 2016/08/08)
  87. +
  88. + New: Added a new PolarManifold descriptor, that uses a polar coordinate + system to compute new points, and modified the existing SphericalManifold + descriptor to use geodesics on the surface of the sphere. +
    + (Luca Heltai, Mauro Bardelloni, 2016/08/04) +
  89. +
  90. Improved: The regular and hp versions of DoFTools::make_flux_sparsity_pattern() no longer use the user flags of the underlying triangulation to determine if entries along a certain face have been @@ -647,6 +529,12 @@ inconvenience this causes. (David Wells, 2016/03/02 - 2016/08/02)
  91. +
  92. New: Introduce operators for residuals and interior penalty terms for + the Grad-Div operator in LocalIntegrators::GradDiv. +
    + (Timo Heister, Guido Kanschat, 2016/08/02) +
  93. +
  94. Improved: DoFTools::make_cell_patches() can create block lists only extending over local cells of distributed triangulations.
    @@ -688,6 +576,27 @@ inconvenience this causes. (Sam Cox, 2016/07/25)
  95. +
  96. + Improved: VectorTools::interpolate() may now be used on FESystems with mixed + interpolating and non-interpolating FEs, if all of the selected components for + interpolation originate from interpolating FEs. +
    + (Jonathan Robey, 2016/07/24) +
  97. + +
  98. + Improved: VectorTools::interpolate() now takes a ComponentMask to select the + components to interpolate. +
    + (Jonathan Robey, 2016/07/21) +
  99. + +
  100. Improved: Split out pattern descriptions for LaTeX and Description + ParameterHandler OutputStyles, and add better description text. +
    + (Jonathan Robey, 2016/07/21) +
  101. +
  102. Improved: Allow for including dofs for individual components on boundary in DoFTools::make_vertex_patches().
    @@ -702,6 +611,13 @@ inconvenience this causes. (Daniel Arndt, 2016/07/20)
  103. +
  104. New: Added GridGenerator::quarter_hyper_ball() to generate the + intersection of a hyper ball with the positive orthant relative + to its center. +
    + (Daniel Arndt, 2016/07/19) +
  105. +
  106. Fixed: Work around an issue with the OpenMPI installation on certain Ubuntu versions: The build system now automatically drops the "-fuse-ld=gold" linker flag if openmpi is incompatible with it. @@ -761,6 +677,22 @@ inconvenience this causes. (Wolfgang Bangerth, 2016/07/01)
  107. +
  108. New: Added TrilinosWrappers::SolveDirect::initialize and + TrilinosWrappers::SolverDirect::solve to solve distributed linear systems + with multiple right hand sides without needing to refactorize the matrix + everytime. +
    + (Michael Harmon, 2016/06/30) +
  109. + +
  110. Changed: Similar to MappingQEulerian, MappingQ1Eulerian has gained + a second constructor that reverses the order of the arguments to indicate + which DoFHandler a vector is based on. The old constructor is now + deprecated and will be removed in a future version. +
    + (Wolfgang Bangerth, 2016/06/25) +
  111. +
  112. New: The MappingFEField class was previously only instantiated if the vector type was dealii::Vector. It is now also instantiated for PETSc and Trilinos wrapper vector types. @@ -835,6 +767,20 @@ inconvenience this causes. (Alberto Sartori, 2016/05/19)
  113. +
  114. New: Add VectorTools::compute_global_error that computes global + errors from cellwise errors obtained by VectorTools::integrate_difference() + and do MPI collectives if necessary. +
    + (Timo Heister, 2016/05/15) +
  115. + +
  116. New: Add functions to transform Cartesian coordinates to spherical and back: + GeometricUtilities::Coordinates::to_spherical and + GeometricUtilities::Coordinates::from_spherical. +
    + (Denis Davydov, 2016/05/10) +
  117. +
  118. Fixed: Corrected the sign of curl calculated in the functions: LocalIntegrators::curl_curl_matrix, LocalIntegrators::curl_matrix, LocalIntegrators::nitsche_curl_matrix and LocalIntegrators::ip_curl_matrix in @@ -843,6 +789,14 @@ inconvenience this causes. (Jihuan Tian, 2016/05/09)
  119. +
  120. Improved: The method Triangulation::create_triangulation will now throw an + exception if any cells have negative measure. This check is not run if the + triangulation keeps track of distorted cells or if the codimension is not zero. + This check was previously only run in 3D. +
    + (David Wells, 2016/05/07) +
  121. +
  122. Fixed: Bug in the RelaxationBlock class function do_step. Before, the corrections were not added together, which leads to a wrong update whenever the Jacobi blocks are overlapping. For SOR, SSOR and non-overlapping Jacobi this was @@ -924,6 +878,13 @@ inconvenience this causes. (Mauro Bardelloni, 2016/04/13)
  123. +
  124. New: Added TensorProductManifold to create new manifolds from two + ChartManifold objects. This can be used, for example, to combine a + 2d manifold with a flat manifold for an extruded mesh. +
    + (Timo Heister, 2016/04/12) +
  125. +
  126. Fixed and improved: Fix algorithm for incomplete assignment of level subdomain ids for parallel geometric multigrid. Also optimize algorithms used for assignment and DoF communication. @@ -931,6 +892,16 @@ inconvenience this causes. (Timo Heister, Martin Kronbichler, 2016/04/12)
  127. +
  128. New: Added New option in the read_ucd function of the GridIn class. + A flag can now be assigned to the function, to decide wether the + indicators specified in a UCD file should be interpreted as + boundary_ids or as manifold_ids. This is particularly useful + when the indicators refer to internal faces, for which + boundary_ids cannot be used. +
    + (Andrea Mola, 2016/04/11) +
  129. +
  130. Improved: DoFRenumbering::compute_Cuthill_McKee when used with distributed triangulations contained parts that scaled as the global problem size, rather than the processor-local size. This prevented its use with more @@ -947,6 +918,13 @@ inconvenience this causes. (Giuseppe Pitton, Luca Heltai, 2016/04/11)
  131. +
  132. New: Added CompositionManifold to create new manifolds from two + ChartManifold objects. This can be used, for example, to rotate a + cylindrical Manifold, or to make a cylinders with parabolic sides. +
    + (Luca Heltai, 2016/04/09) +
  133. +
  134. Fixed: Meshworker::Assembler::ResidualSimple now also works for multiple blocks if no constraints are given.
    @@ -997,6 +975,13 @@ inconvenience this causes. (Daniel Arndt, Ali Samii, 2016/03/23)
  135. +
  136. New: Added GridGenerator::torus() to generate the volume mesh of a + torus in three dimensions and a manifold description TorusManifold to + go with it. +
    + (Timo Heister, 2016/03/21) +
  137. +
  138. Fixed: DoFHandler::locally_owned_dofs() could create a segmentation fault in cases where some processors do not own any cells. This was caused by an incorrect computation in DoFTools::locally_owned_dofs_per_subdomain(). @@ -1012,6 +997,11 @@ inconvenience this causes. (Martin Kronbichler, 2016/03/18)
  139. +
  140. New: Added GridTools::rotate() in three space dimensions. +
    + (Timo Heister, 2016/03/18) +
  141. +
  142. New: Added custom target "relocate" to Mac OS X builds, that runs a script to make all paths absolute in the shared libraries included in the deal.II package (only enabled when building a package, and when @@ -1020,6 +1010,11 @@ inconvenience this causes. (Luca Heltai, 2016/03/14)
  143. +
  144. New: Added unit tests for complex-valued PETSc and SLEPc. +
    + (Toby D. Young, Denis Davydov, 2016/03/11) +
  145. +
  146. New: Add NURBSPatchManifold. This class is a child of ChartManifold and implements a manifold descriptor for the face of a CAD imported usign OpenCASCADE. @@ -1036,6 +1031,11 @@ inconvenience this causes. (Wolfgang Bangerth, 2016/03/07)
  147. +
  148. New: Added another scaling factor to Kelly error estimator, namely h_K. +
    + (Denis Davydov, 2016/03/05) +
  149. +
  150. New: When using C++11, the function filter_iterators() allows to filter a range of iterators using predicates (like the ones defined in IteratorFilter).