]>
https://gitweb.dealii.org/ - dealii.git/log
Luca Heltai [Sun, 28 Feb 2016 23:22:52 +0000 (00:22 +0100)]
Merge pull request #2260 from bangerth/simplify-function
Simplify the implementation of a function.
Luca Heltai [Sun, 28 Feb 2016 23:21:29 +0000 (00:21 +0100)]
Merge pull request #2264 from bangerth/remove-deprecated-functions-15
Remove deprecated functions with names like 'boundary_indicator'.
Matthias Maier [Sun, 28 Feb 2016 22:26:08 +0000 (16:26 -0600)]
Merge pull request #2262 from drwells/fix-lapack-bindings-on-bsd
Avoid boost functions that don't work on BSDs.
Wolfgang Bangerth [Sun, 28 Feb 2016 21:44:37 +0000 (15:44 -0600)]
Rename an internal function to be consistent with the naming scheme elsewhere.
Wolfgang Bangerth [Sun, 28 Feb 2016 21:43:08 +0000 (15:43 -0600)]
Remove deprecated functions with names like 'boundary_indicator'.
They had previously already been replaced by functions with name 'boundary_id', to
be consistent with the spelling for other attributes such as subdomain_id,
material_id, etc.
David Wells [Sun, 28 Feb 2016 21:08:06 +0000 (16:08 -0500)]
Avoid boost functions that don't work on BSDs.
As was noted in issue #2261, the function boost::math::iround cannot be
used on some BSD variants due to the following compilation error:
In file included from /root/workspace/dealii/source/lac/lapack_full_matrix.cc:25:
In file included from /usr/local/include/boost/math/special_functions/round.hpp:15:
In file included from /usr/local/include/boost/math/special_functions/fpclassify.hpp:19:
In file included from /usr/local/include/boost/math/special_functions/math_fwd.hpp:26:
In file included from /usr/local/include/boost/math/special_functions/detail/round_fwd.hpp:12:
/usr/local/include/boost/math/tools/promotion.hpp:141:10: error: static_assert failed
"Sorry, but this platform does not have sufficient long double support for the special functions to be reliably implemented."
BOOST_STATIC_ASSERT_MSG((0 == ::boost::is_same<type, long
double>::value),
"Sorry, but this platform does not have sufficient long double support for the special functions to be reliably implement ed.");
/usr/local/include/boost/static_assert.hpp:31:45: note: expanded from macro 'BOOST_STATIC_ASSERT_MSG'
Since we only use iround for clarity this is not hard to work around.
A note on the implementation: LAPACK functions can usually be run in two
different modes. In the first, they compute the optimal size of the work
array. In the second they actually execute the function. Therefore
all we need to do is make the work arrays one longer and we should still
get the same performance out of LAPACK without needing to worry about
any unforeseen roundoff issues.
Luca Heltai [Sun, 28 Feb 2016 19:08:14 +0000 (20:08 +0100)]
Merge pull request #2259 from bangerth/extend-manifolds
Extend manifolds
Wolfgang Bangerth [Sun, 28 Feb 2016 18:59:35 +0000 (12:59 -0600)]
Provide a default implementation of Manifold::get_tangent_vector().
Wolfgang Bangerth [Sun, 28 Feb 2016 18:50:02 +0000 (12:50 -0600)]
Augment documentation.
Wolfgang Bangerth [Sun, 28 Feb 2016 17:54:16 +0000 (11:54 -0600)]
Add tests.
Wolfgang Bangerth [Sun, 28 Feb 2016 17:53:41 +0000 (11:53 -0600)]
Implement Manifold::get_direction_vector() in FlatManifold.
Wolfgang Bangerth [Sun, 28 Feb 2016 17:52:34 +0000 (11:52 -0600)]
Add a member function Manifold::get_direction_vector().
Luca Heltai [Sun, 28 Feb 2016 18:55:55 +0000 (19:55 +0100)]
Merge pull request #2250 from bangerth/doc-update-49
Extend documentation of the Manifold class.
Wolfgang Bangerth [Sun, 28 Feb 2016 18:06:45 +0000 (12:06 -0600)]
Simplify the implementation of a function.
In particular, write an assertion with less code. Also remove some
alias variables.
Wolfgang Bangerth [Sat, 27 Feb 2016 22:31:32 +0000 (16:31 -0600)]
Extend documentation of the Manifold class.
Denis Davydov [Sun, 28 Feb 2016 18:06:13 +0000 (19:06 +0100)]
Merge pull request #2257 from davydden/branch_petscscalar_complex_bits_3
add a message why one should not use GridRefinement functions with co…
Denis Davydov [Sun, 28 Feb 2016 16:16:04 +0000 (17:16 +0100)]
add a message why one should not use GridRefinement functions with complex-valued PETSc
Wolfgang Bangerth [Sun, 28 Feb 2016 17:59:27 +0000 (11:59 -0600)]
Merge pull request #2258 from appiazzolla/master
Make AdditionalData available from PreconditionBlockJacobi
x [Sun, 28 Feb 2016 16:25:49 +0000 (17:25 +0100)]
Make AdditionalData available from PreconditionBlockJacobi
Wolfgang Bangerth [Sun, 28 Feb 2016 14:16:39 +0000 (08:16 -0600)]
Merge pull request #2254 from davydden/branch_petscscalar_complex_bits_2
some bits towards complex-valued PETSc (part 2)
Denis Davydov [Sun, 28 Feb 2016 10:38:21 +0000 (11:38 +0100)]
extend MatrixTools::create_boundary_mass_matrix() for complex algebra
Most of the modifications are change of the multiplication order from
double * std::complex<scalar> to std::complex<scalar> * double.
Instantiate create_mass_matrix() and create_boundary_mass_matrix()
for complex case.
Denis Davydov [Sun, 28 Feb 2016 10:32:58 +0000 (11:32 +0100)]
adjust functions in ConstraintMatrix to compile with complex algebra
modified condense(), set_matrix_digonals() and resolve_vector_entry()
by swapping the order of multiplications.
Instantiate distribute_local_to_global() and condense() for complex
algebra.
Denis Davydov [Sun, 28 Feb 2016 10:28:23 +0000 (11:28 +0100)]
instantiate DoFTools::make_boundary_sparsity_pattern() for complex scalars
Wolfgang Bangerth [Sun, 28 Feb 2016 11:58:05 +0000 (05:58 -0600)]
Merge pull request #2249 from davydden/branch_petscscalar_complex_bits_1
some bits towards complex-valued PETSc
Wolfgang Bangerth [Sun, 28 Feb 2016 11:53:33 +0000 (05:53 -0600)]
Merge pull request #2251 from drwells/update-triangulation-comment-style
Update triangulation comment style
Denis Davydov [Sun, 28 Feb 2016 01:45:09 +0000 (02:45 +0100)]
minor fixes of auxiliary function in vector tools
David Wells [Sat, 27 Feb 2016 22:48:02 +0000 (17:48 -0500)]
Skip misleading links in tria.h.
David Wells [Sat, 27 Feb 2016 22:47:51 +0000 (17:47 -0500)]
Reformat example code in tria.h.
Denis Davydov [Sat, 27 Feb 2016 21:24:08 +0000 (22:24 +0100)]
minor extension of mass_assembler() in matrix tools for complex numbers
Denis Davydov [Sat, 27 Feb 2016 21:07:04 +0000 (22:07 +0100)]
extend MatrixTools::apply_boundary_values() to complex numbers
Denis Davydov [Sat, 27 Feb 2016 20:41:25 +0000 (21:41 +0100)]
move instantiation of MatrixTools::apply_boundary_values() to inst.in file
Denis Davydov [Sat, 27 Feb 2016 20:19:22 +0000 (21:19 +0100)]
instantiate n_boundary_dofs() for COMPLEX_SCALARS
Denis Davydov [Sat, 27 Feb 2016 20:12:59 +0000 (21:12 +0100)]
extend do_project() for complex numbers with ExcNotImplemented() for solver
Denis Davydov [Sat, 27 Feb 2016 20:07:30 +0000 (21:07 +0100)]
extend do_project_boundary_values() to complex numbers with ExcNotImplemented for solver
Denis Davydov [Sat, 27 Feb 2016 19:07:22 +0000 (20:07 +0100)]
fix apply_boundary_values() for PETSc
Wolfgang Bangerth [Sat, 27 Feb 2016 07:43:39 +0000 (01:43 -0600)]
Merge pull request #2241 from davydden/branch_petscscalar_complex_vectortools2
finish templating VectorTools; introduce templates to MatrixTools and…
Denis Davydov [Sat, 27 Feb 2016 02:59:54 +0000 (03:59 +0100)]
add an entry to changes.h
Denis Davydov [Sat, 27 Feb 2016 01:30:48 +0000 (02:30 +0100)]
add a few blank lines and use different include to get PetscScalar
Denis Davydov [Fri, 26 Feb 2016 18:40:08 +0000 (19:40 +0100)]
consolidate definitions of TrilinosScalar in base/types.h as a typedef
Denis Davydov [Tue, 23 Feb 2016 15:31:12 +0000 (16:31 +0100)]
continue templating VectorTools; introduce templates to MatrixTools and DoFTools
(i) drop the typedef FunctionMap from (hp::)DoFHandler and template n_boundary_dofs().
Fix a few places where it was used.
(ii) template make_boundary_sparsity_pattern(...,FunctionMap,...)
(iii) new templates in MatrixCreator::
create_mass_matrix(), create_boundary_mass_matrix(),
apply_boundary_values() and local_apply_boundary_values().
(iv) number templates in VectorTools::
interpolate_boundary_values(), project_boundary_values(),
(v) instantiate ConstraintMatrix::distribute_local_to_global for SparseMatrix<long double>
Wolfgang Bangerth [Thu, 25 Feb 2016 21:30:55 +0000 (15:30 -0600)]
Merge pull request #2245 from tjhei/blacklist_intel_1601
blacklist intel 16.0.1
Bruno Turcksin [Thu, 25 Feb 2016 18:21:36 +0000 (13:21 -0500)]
Merge pull request #2243 from tjhei/bug_mpi_allgather_type
fix incorrect MPI_Allgather
Timo Heister [Thu, 25 Feb 2016 17:29:55 +0000 (12:29 -0500)]
blacklist intel 16.0.1
Timo Heister [Thu, 25 Feb 2016 17:21:49 +0000 (12:21 -0500)]
fix incorrect MPI_Allgather
MPI_Allgather in compute_local_to_global_vertex_index_map() was using
the wrong data type, which probably lead to wrong results or at least
illegal memory access.
Bruno Turcksin [Wed, 24 Feb 2016 23:01:39 +0000 (18:01 -0500)]
Merge pull request #2242 from Rombur/trilinos_sparsity_pattern
Fix a bug in make_trilinos_map()
Bruno Turcksin [Wed, 24 Feb 2016 20:10:59 +0000 (15:10 -0500)]
Fix a bug in make_trilinos_map() where different processors would call different Epetra_Map constructor.
Martin Kronbichler [Wed, 24 Feb 2016 07:14:35 +0000 (08:14 +0100)]
Merge pull request #2238 from tjhei/step-22-document-stokes-op
step-22: document symmetric gradient
Timo Heister [Tue, 23 Feb 2016 18:04:17 +0000 (13:04 -0500)]
step-22: document symmetric gradient
Martin Kronbichler [Tue, 23 Feb 2016 18:17:56 +0000 (19:17 +0100)]
Merge pull request #2239 from drwells/fix-step-20-refactoring
Fix step-20 compilation.
David Wells [Tue, 23 Feb 2016 18:12:12 +0000 (13:12 -0500)]
Fix step-20 compilation.
76874a2160 did not correctly name a field of a class.
Denis Davydov [Tue, 23 Feb 2016 15:32:41 +0000 (16:32 +0100)]
Merge pull request #2235 from davydden/fix_fe_field_function_vector_gradient
fixed a bug in FEFieldFunction::vector_gradient() introduced in
0dc4d47
Denis Davydov [Tue, 23 Feb 2016 13:33:12 +0000 (14:33 +0100)]
fixed a bug in FEFieldFunction::vector_gradient() introduced in
0dc4d47
Martin Kronbichler [Tue, 23 Feb 2016 13:04:56 +0000 (14:04 +0100)]
Merge pull request #2234 from davydden/fix_vector_tools_interpolate_mat_id
fixed a bug introduced to VectorTools::interpolate_based_on_material_…
Denis Davydov [Tue, 23 Feb 2016 12:57:59 +0000 (13:57 +0100)]
fixed a bug introduced to VectorTools::interpolate_based_on_material_id() in
519d8b9
Wolfgang Bangerth [Tue, 23 Feb 2016 11:59:38 +0000 (05:59 -0600)]
Merge pull request #2227 from davydden/missing_include_tria_h
add a missing include for std::accumulate()
Denis Davydov [Tue, 23 Feb 2016 05:36:49 +0000 (06:36 +0100)]
Merge pull request #2226 from davydden/branch_petscscalar_complex_temporarymasking
temporary masking of few places for complex-valued PETSc
Denis Davydov [Mon, 22 Feb 2016 12:55:17 +0000 (13:55 +0100)]
temporary avoid instantiations of PointValueHistory, DerivativeApproximation and DataOut-related classes for complex-valued PETSc
Wolfgang Bangerth [Mon, 22 Feb 2016 23:31:30 +0000 (17:31 -0600)]
Merge pull request #2229 from davydden/fix_point_value_history
fix PointValueHistory to work with the updated VectorTools::point_val…
Denis Davydov [Mon, 22 Feb 2016 22:30:55 +0000 (23:30 +0100)]
fix PointValueHistory to work with the updated VectorTools::point_value()
Denis Davydov [Mon, 22 Feb 2016 17:51:45 +0000 (18:51 +0100)]
add a missing include for std::accumulate()
Denis Davydov [Mon, 22 Feb 2016 12:52:33 +0000 (13:52 +0100)]
temporary mark max/min element in grid_refinement for complex-valued PETSc as NotImplemented
Wolfgang Bangerth [Mon, 22 Feb 2016 17:04:27 +0000 (11:04 -0600)]
Merge pull request #2218 from davydden/branch_petscscalar_complex_error
extend error estimator to complex-valued PETSc
Wolfgang Bangerth [Mon, 22 Feb 2016 17:03:09 +0000 (11:03 -0600)]
Merge pull request #2220 from davydden/branch_petscscalar_complex_fetools
minor change to fe_tools_interpolate to allow complex-valued vectors
Denis Davydov [Mon, 22 Feb 2016 17:01:15 +0000 (18:01 +0100)]
Merge pull request #2217 from davydden/branch_petscscalar_complex_vectortools
extend VectorTools to complex-valued PETSc vector
Denis Davydov [Mon, 22 Feb 2016 12:37:20 +0000 (13:37 +0100)]
extend VectorTools to complex-valued PETSc vector
Wolfgang Bangerth [Mon, 22 Feb 2016 16:56:32 +0000 (10:56 -0600)]
Merge pull request #2222 from davydden/branch_petscscalar_complex_constraint
change instantiation of constraint matrix functions to allow complex-…
Wolfgang Bangerth [Mon, 22 Feb 2016 16:56:02 +0000 (10:56 -0600)]
Merge pull request #2225 from davydden/branch_petscscalar_complex_mappingeulerian
do not instantiate mapping eulerian for complex-valued PETSc
Wolfgang Bangerth [Mon, 22 Feb 2016 16:55:37 +0000 (10:55 -0600)]
Merge pull request #2223 from davydden/branch_petscscalar_complex_boomer
add extra ifndef to disable BoomerAMG for complex-valued PETSc
Denis Davydov [Mon, 22 Feb 2016 12:45:39 +0000 (13:45 +0100)]
change instantiation of constraint matrix functions to allow complex-valued vectors
Denis Davydov [Mon, 22 Feb 2016 12:49:53 +0000 (13:49 +0100)]
do not instantiate mapping eulerian for complex-valued PETSc
Denis Davydov [Mon, 22 Feb 2016 12:46:50 +0000 (13:46 +0100)]
add extra ifndef to disable BoomerAMG for complex-valued PETSc
Denis Davydov [Mon, 22 Feb 2016 12:42:32 +0000 (13:42 +0100)]
minor change to fe_tools_interpolate to allow complex-valued vectors
Denis Davydov [Mon, 22 Feb 2016 12:39:15 +0000 (13:39 +0100)]
extend error estimator to complex-valued PETSc
Wolfgang Bangerth [Mon, 22 Feb 2016 13:19:02 +0000 (07:19 -0600)]
Merge pull request #2221 from davydden/branch_petscscalar_complex_dofaccessor
change dof_accessor get/set instantiations to allow complex-valued ve…
Wolfgang Bangerth [Mon, 22 Feb 2016 13:13:36 +0000 (07:13 -0600)]
Merge pull request #2219 from davydden/branch_petscscalar_complex_fefieldfunction
extend FEFieldFunction to complex-valued vectors
Denis Davydov [Mon, 22 Feb 2016 12:43:33 +0000 (13:43 +0100)]
change dof_accessor get/set instantiations to allow complex-valued vectors
Denis Davydov [Mon, 22 Feb 2016 12:41:11 +0000 (13:41 +0100)]
extend FEFieldFunction to complex-valued vectors
Wolfgang Bangerth [Mon, 22 Feb 2016 13:07:21 +0000 (07:07 -0600)]
Merge pull request #2216 from davydden/branch_petscscalar_complex_block
minor adjustments to block matrix and vector to work with complex PETSc
Denis Davydov [Mon, 22 Feb 2016 12:29:45 +0000 (13:29 +0100)]
minor adjustments to block matrix and vector to work with complex PETSc
Wolfgang Bangerth [Mon, 22 Feb 2016 13:00:35 +0000 (07:00 -0600)]
Merge pull request #2215 from drwells/example-template-parameters-2
Prefer PreconditionerType to Preconditioner.
David Wells [Mon, 22 Feb 2016 04:23:43 +0000 (23:23 -0500)]
Prefer PreconditionerType to Preconditioner.
This commit updates the tutorials to use the same naming convention as
the rest of the library.
David Wells [Mon, 22 Feb 2016 02:23:15 +0000 (21:23 -0500)]
Merge pull request #2214 from bangerth/simplify-code-2
Simplify the code that accumulates the weights for cells during partitioning.
Wolfgang Bangerth [Mon, 22 Feb 2016 01:39:10 +0000 (19:39 -0600)]
Simplify the code that accumulates the weights for cells during partitioning.
Timo Heister [Sun, 21 Feb 2016 14:25:24 +0000 (09:25 -0500)]
Merge pull request #2213 from drwells/example-template-parameters
Prefer MatrixType to Matrix in the tutorials.
Timo Heister [Sun, 21 Feb 2016 14:24:04 +0000 (09:24 -0500)]
Merge pull request #2211 from drwells/update-step-20
Update step 20
David Wells [Sun, 21 Feb 2016 14:18:32 +0000 (09:18 -0500)]
Prefer MatrixType to Matrix in the tutorials.
David Wells [Sun, 21 Feb 2016 14:08:22 +0000 (09:08 -0500)]
Relate versions of InverseMatrix in steps 20-22.
David Wells [Sun, 21 Feb 2016 01:14:32 +0000 (20:14 -0500)]
Do not label plain classes as templates.
David Wells [Sat, 20 Feb 2016 23:41:57 +0000 (18:41 -0500)]
Get rid of IterativeInverse in step-20.
IterativeInverse was marked as deprecated in April 2015 in favor of
LinearOperator. This puts this step in a strange place; we should not
use deprecated features in tutorials, but at the same time we cannot use
its replacement, which requires C++11 support. To resolve this, this
step just provides its own replacement for a special case of
IterativeInverse.
David Wells [Sat, 20 Feb 2016 22:15:23 +0000 (17:15 -0500)]
Remove some trailing whitespace.
David Wells [Sat, 20 Feb 2016 22:15:12 +0000 (17:15 -0500)]
Fix a typo in the step-20 introduction.
David Wells [Sat, 20 Feb 2016 18:12:33 +0000 (13:12 -0500)]
Change initialization to avoid a static variable.
m_inverse depends on inner_control, so initialize inner_control first
rather than making it static.
David Wells [Sat, 20 Feb 2016 18:05:07 +0000 (13:05 -0500)]
Prefer face_n to face_no.
David Wells [Fri, 19 Feb 2016 01:39:35 +0000 (20:39 -0500)]
Merge pull request #2207 from bangerth/avoid-includes
Avoid a bunch of #include files that turn out to be not necessary.
Wolfgang Bangerth [Fri, 19 Feb 2016 00:54:30 +0000 (18:54 -0600)]
Avoid a bunch of #include files that turn out to be not necessary.
Wolfgang Bangerth [Thu, 18 Feb 2016 21:51:40 +0000 (15:51 -0600)]
Merge pull request #2205 from jppelteret/step-44-dim_indep
Update step-44 to be dimension independent
Jean-Paul Pelteret [Thu, 18 Feb 2016 16:25:16 +0000 (18:25 +0200)]
Astyle... finally...
Jean-Paul Pelteret [Thu, 18 Feb 2016 16:10:44 +0000 (18:10 +0200)]
Added 2-d results and updated changelog
David Wells [Wed, 17 Feb 2016 14:06:20 +0000 (09:06 -0500)]
Merge pull request #2204 from bangerth/use-proper-code-gallery-name
Use proper code gallery name
Jean-Paul Pelteret [Wed, 17 Feb 2016 12:54:02 +0000 (14:54 +0200)]
Adjust comments.
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.