Re: [deal.II] Error during P4EST installation

2016-05-18 Thread Wolfgang Bangerth
config.log in the p4est build directory. You'll need to look into this file to find out about the cause why it thinks that the F77 compiler isn't usable. Best W. -- ---- Wolfgang Bangerth email:

Re: [deal.II] Help with interpretation of PETSc and SLEPc error message.

2016-05-19 Thread Wolfgang Bangerth
display this data file so that they can show the values in correct order just like in MATLAB. You can do this in gnuplot: set style data lines set hidden3d splot "M.gnuplot" using 1:2:3 Best W. -- ---- Wol

Re: [deal.II] What if the parameter "n_subdivisions" passed to "build_patches()" bigger than the finite element order?

2016-05-21 Thread Wolfgang Bangerth
. -- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list

Re: [deal.II] Segmentation fault in WorkStream::run() for colored iterators in parallel(MPI)

2016-05-24 Thread Wolfgang Bangerth
. -- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https

Re: [deal.II] deal__ paper on wave propagation

2016-05-27 Thread Wolfgang Bangerth
l Best W. -- ---- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options,

Re: [deal.II] avoid file system lock when calling P::D::SolutionTransfer::prepare_serialization() ?

2016-06-01 Thread Wolfgang Bangerth
this function (as far as I can see) doesn't actually do any i/o. Can you get a backtrace to where the problem with the error above actually happens? Best W. -- ---- Wolfgang Bangerth email:bange...

Re: [deal.II] Navier Stokes outflow conditions

2016-06-03 Thread Wolfgang Bangerth
term? Best W. -- ---- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/for

Re: [deal.II] Recommendations for numerical grid generation

2016-06-06 Thread Wolfgang Bangerth
community would agree with this. Best W. -- ---- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is

Re: [deal.II] Re: deal.ii and Trilinos

2016-06-08 Thread Wolfgang Bangerth
st W. -- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/

Re: [deal.II] Re: Compilation problem on Power8 system

2016-06-09 Thread Wolfgang Bangerth
l.II. Best W. -- ---- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.goo

Re: [deal.II] Transfer of quadrature point history data after mesh refinement.

2016-06-14 Thread Wolfgang Bangerth
quadrature point data. Then you need a separate (second) SolutionTransfer object for the second DoFHandler. Best W. -- Wolfgang Bangerth email:bange...@math.tamu.edu

Re: [deal.II] WorkStream iterator

2016-06-19 Thread Wolfgang Bangerth
mode. Daniel, you are looking for the SynchronousIterator class :-) Cheers W. -- ---- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For

Re: [deal.II] Re: Entry of the own problem in dealii

2016-06-22 Thread Wolfgang Bangerth
distance of the crack). This is what is done in step-1, for example. Best W. -- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth

Re: [deal.II] Fast FE evaluation over several points and several functions

2016-06-22 Thread Wolfgang Bangerth
efficient and independent of the overall size of the problem. Best W. -- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The

Re: [deal.II] Adding dirichlet values to ConstraintMatrix

2016-06-22 Thread Wolfgang Bangerth
. -- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/forum/dealii?hl=en

Re: [deal.II] Adding dirichlet values to ConstraintMatrix

2016-06-23 Thread Wolfgang Bangerth
s good! Best W. -- ---- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum op

Re: [deal.II] On the use of MappingFEField

2016-06-24 Thread Wolfgang Bangerth
ss has already taken its address, and so you get the error above. What you need to do is use the second template argument of the MappingFEField class and set it to TrilinosWrappers::MPI::Vector. This should make it all work! Best Wolfgang -- -

Re: [deal.II] On the use of MappingFEField

2016-06-24 Thread Wolfgang Bangerth
2, 2> const&, dealii::TrilinosWrappers::MPI::Vector const&, dealii::ComponentMask)", referenced from: _main in main.cc.o Indeed. You need this patch: https://github.com/dealii/dealii/pull/2717 Best W. -- --

Re: [deal.II] Re: which version of trilinos for dealii-8.4.1

2016-06-29 Thread Wolfgang Bangerth
You can try to make it work by not running multiple compilers in parallel (with -jN), or by closing other programs that are running at the time, or by adding swap space. Best W. -- ---- Wolfgang Bangerth email:

Re: [deal.II] Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range

2016-07-03 Thread Wolfgang Bangerth
? Best W. -- ---- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/forum/dealii?hl=

Re: [deal.II] Dealing with conflicting constraints

2016-07-05 Thread Wolfgang Bangerth
2Xl2-E8Tbg0or5hD9WqUYXEKaSyPYc&s=g6gaCUE0kHiyFVTtZYEm3loEhpwmQKH7FkZCX1J1OIE&e=>. I was totally confused. Which one is right? It seems to me that both of these texts describe what the functions do. But they do different things. I think the first one does the correct th

Re: [deal.II] Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range

2016-07-05 Thread Wolfgang Bangerth
by seeing which functions are being called. Once you find out which function creates the problem, you can again look at the arguments and local variables and see what is happening. Best W. -- ---- Wolfgang Bangerth

Re: [deal.II] (Multigrid) preconditioner for the PML method

2016-07-05 Thread Wolfgang Bangerth
st W. -- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options

Re: [deal.II] (Multigrid) preconditioner for the PML method

2016-07-05 Thread Wolfgang Bangerth
matrices. Another line of investigation would be to try something like an ILU as preconditioner, to make sure again that it really is the preconditioner, not the matrix, that is the problem. Best W. -- Wolfgang Bangerth

Re: [deal.II] repartition of parallel::shared::Triangulation

2016-07-10 Thread Wolfgang Bangerth
that's not how this currently works with p::d::Triangulation (which has a much more complicated scheme). So I'm not sure how much making such a function virtual would actually help. Best W. -- ---- Wolfgang Bangerth

[deal.II] Re: Doubt in FEvalues

2016-07-11 Thread Wolfgang Bangerth
For reference, I posted a patch for this problem here: https://github.com/dealii/dealii/pull/2804 A discussion of what is happening is here: https://github.com/dealii/dealii/issues/2661 Thanks for the nice and small testcase! W. On Wednesday, June 1, 2016 at 1:10:45 AM UTC-5, Jean-Paul Pelter

Re: [deal.II] Re: Problem building dealii with PETSc

2016-07-11 Thread Wolfgang Bangerth
ut without --download-mpich. Best W. -- ---- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is locat

Re: [deal.II] Re: Entry of the own problem in dealii

2016-07-12 Thread Wolfgang Bangerth
. Best W. -- ---- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options,

Re: [deal.II] Re: Problem building dealii with PETSc

2016-07-12 Thread Wolfgang Bangerth
i" or "mpich"? > Is my inteperetation of the instructions correct, or do I have to > remove openmpi-dev. I'd try to start from as clean a slate as possible every time. Best W. -- ---- Wolfga

Re: [deal.II] Bug in sparse_matrix.templates.h

2016-07-14 Thread Wolfgang Bangerth
.) Best W. -- ---- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.

Re: [deal.II] Possibly wrong format of msh file

2016-07-15 Thread Wolfgang Bangerth
mesh has a few cells that are degenerate or inverted. The error message is, admittedly, not very useful. I'll write a patch. Best W. -- ---- Wolfgang Bangerth email:

Re: [deal.II] Bug in sparse_matrix.templates.h

2016-07-15 Thread Wolfgang Bangerth
On 07/15/2016 07:56 AM, Michał Wichrowski wrote: I think it would be helpful if there was something about it in documentation. Good point -- see https://github.com/dealii/dealii/pull/2836 Cheers W> -- ---- Wolfg

Re: [deal.II] axis-symmetric problem

2016-07-15 Thread Wolfgang Bangerth
hat 2*pi*r factor in the integral. As long as you make sure all of the terms you integrate have the appropriate scaling, you will be fine. Best W. -- ---- Wolfgang Bangerth email:ba

Re: [deal.II] How to access solution values at DoFs of a cell?

2016-07-22 Thread Wolfgang Bangerth
ues); Best W. -- ---- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/

Re: [deal.II] Re: Decoupling FECollection and QCollection

2016-07-23 Thread Wolfgang Bangerth
and submit a pull request for your changes? I've opened the following pull request for this: https://github.com/dealii/dealii/pull/2854 Best W. -- ---- Wolfgang Bangerth email:bange

Re: [deal.II] Re: Decoupling FECollection and QCollection

2016-07-25 Thread Wolfgang Bangerth
Your answers clarified by doubt and thanks Wolfgang for updating it already. I realize now that the same issue also applies to MappingCollection. Will fix in a follow-up patch. Best W. -- Wolfgang Bangerth

Re: [deal.II] Problem using WorkStream with a hp::DoFHandler

2016-07-26 Thread Wolfgang Bangerth
ument of the local assembly function to active_cell_iterator and it should all work. Best W. -- ---- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.

Re: [deal.II] question about compute_projection_from_quadrature_points_matrix function

2016-07-26 Thread Wolfgang Bangerth
. -- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https

Re: [deal.II] Issue on Windows x64 Debug linkage

2016-07-27 Thread Wolfgang Bangerth
n offer from afar... Best W. -- ---- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://gr

Re: [deal.II] Re: PETScWrappers::SparseDirectMUMPS for symmetry system matrix and factorization resue

2016-07-27 Thread Wolfgang Bangerth
On 07/27/2016 01:43 PM, Alexander wrote: step-17 claims to solve same problem as step-8. If one produces symmetry matrix and the other does not or both do not -- this is suspicious. The reason why the matrix in step-17 is not symmetric is actually explained in the code: // The last argu

Re: [deal.II] Issue on Windows x64 Debug linkage

2016-07-28 Thread Wolfgang Bangerth
n Release mode is good enough. OK, good to know that you have an alternative way to work. Best W. -- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~b

Re: [deal.II] Re: A question about velocity correction in Step-35

2016-07-30 Thread Wolfgang Bangerth
ant me to. Best W. -- ---- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.googl

Re: [deal.II] Re: Memory usage using MPI/PETSc on single processor

2016-07-30 Thread Wolfgang Bangerth
like to add a comment to this effect to the program. Best W. -- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The de

Re: [deal.II] Re: A question about velocity correction in Step-35

2016-07-31 Thread Wolfgang Bangerth
On 07/31/2016 05:16 AM, Daniel Arndt wrote: I will create a PR next week including some more references to the analysis for that scheme. That would be much appreciated! Thanks! W. -- Wolfgang Bangerth

Re: [deal.II] HP with parallel::shared::Triangulation

2016-07-31 Thread Wolfgang Bangerth
computations. This is pretty high on our list to get implemented in parallel. Best W. -- Wolfgang Bangerth email:bange...@math.tamu.edu www: http

[deal.II] Development activity over the past year

2016-07-31 Thread Wolfgang Bangerth
ipate.html -- ---- Wolfgang Bangerth email:bange...@math.tamu.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.c

[deal.II] Re: Development activity over the past year

2016-07-31 Thread Wolfgang Bangerth
* 54 distinct people contributed code and documentation over the last year. I am particularly proud of the last number! Cheers W. -- Wolfgang Bangerth email:bange...@math.tam

Re: [deal.II] problems switching from one core to multiple cores - implementation of Chorin's scheme

2016-08-02 Thread Wolfgang Bangerth
On 08/02/2016 12:45 PM, Marek Čapek wrote: I coded it in the step-40 like manner. When I run it on one core (either ./main or mpirun -np 1 main ), the results are physically reasonable. However, when I switch to more cores, e.g. two - "mpirun -np 2 main", I get meaningless solutions. You know, t

Re: [deal.II] Re: Development activity over the past year

2016-08-02 Thread Wolfgang Bangerth
On 08/02/2016 02:33 PM, David Wells wrote: About a year ago I did a bit of analysis on the commit rate: it has gone up significantly over the least few years. Just for fun I attached a plot of the total number of commits over time (as well as some important points in our history) to visualize th

Re: [deal.II] problems switching from one core to multiple cores - implementation of Chorin's scheme

2016-08-02 Thread Wolfgang Bangerth
On 08/02/2016 02:18 PM, Vinetou Incucuna wrote: I have tried to output the solutions from the step one as well as from the step three. There is some development, but reasonable,i.e. solution from the first step and the third step look similar (except the first iteration) In the attachment you ca

Re: [deal.II] Observations on CPU usage on a single processor

2016-08-03 Thread Wolfgang Bangerth
ency comes from. Also, it appears that the efficiency with one CPU decreases as the #DOF increase with PETSc/MPI. Does anyone know why? How do you define "efficiency"? Best W. -- ---- Wolfgang Bangert

Re: [deal.II] Re: Observations on CPU usage on a single processor

2016-08-05 Thread Wolfgang Bangerth
erations that are not parallelized take longer than those that are parallelized, and so overall lead to a lower average thread load. But that's only a theory that would require a lot more digging to verify. Best W. -- ----

Re: [deal.II] Re: Observations on CPU usage on a single processor

2016-08-05 Thread Wolfgang Bangerth
re just not good enough to really compete with the more complex algorithms (which are then harder to parallelize efficiently). Best W. -- ---- Wolfgang Bangerth email:bange.

Re: [deal.II] Re: global dof renumbering with parallel triangulation and trilinos direct solver (Bug ?)

2016-08-08 Thread Wolfgang Bangerth
On 08/08/2016 02:18 PM, Denis Davydov wrote: However, when I changed the partition into something like { 0, 2, 4, ... } , { 1, 3, 5, ... } it fails, which makes me believe that non-contiguous partitions are not (completely) supported by dealii or trilinos should be fine for Tr

Re: [deal.II] Re: casting a 4th order symm tensor to Tensor

2016-08-11 Thread Wolfgang Bangerth
will then be in the next release as well, of course. Best Wolfgang -- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The

[deal.II] Daniel Arndt and Jean-Paul Pelteret appointed deal.II Developers

2016-08-12 Thread Wolfgang Bangerth
gang Bangerth -- ---- Wolfgang Bangerth email:bange...@colostate.edu www: http://www.math.tamu.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mai

Re: [deal.II] error when trying to initialize PETSc preconditioners

2016-08-15 Thread Wolfgang Bangerth
On 08/15/2016 02:46 PM, Ignacio Tomas wrote: Great! Many thanks for solving this problem. I owe at least a lunch. Ah, now I'm jealous I left this easy to fix bug to Timo! ;-) Cheers W. -- Wolfgang Ban

Re: [deal.II] Extracting a component from Block FESystem and DofHandler

2016-08-16 Thread Wolfgang Bangerth
o know about. Cheers W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailin

Re: [deal.II] weakly enforcing an identity - vector mean curvature as the surface laplacian of the identity on a codim-1 manifold

2016-08-17 Thread Wolfgang Bangerth
_X On the left hand side, this results in a mass matrix that you will have to invert to obtain the mean curvature. Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu

[deal.II] Re: [dealii-developers] dealii.org website down?

2016-08-17 Thread Wolfgang Bangerth
it -- expect things to come back up online in the (hopefully) not too far future. Best Wolfgang -- Wolfgang Bangerth email: bange...@colostate.edu www: http

[deal.II] deal.II now also in Colorado

2016-08-17 Thread Wolfgang Bangerth
Colorado/USA. Of course, development of deal.II in reality happens around the world from quite a number of countries, and nothing about that will change! Best Wolfgang -- Wolfgang Bangerth email

Re: [deal.II] weakly enforcing an identity - vector mean curvature as the surface laplacian of the identity on a codim-1 manifold

2016-08-18 Thread Wolfgang Bangerth
ehow). Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For m

Re: [deal.II] copy_triangulation for a collection of triangulations

2016-08-18 Thread Wolfgang Bangerth
of data. Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.

Re: [deal.II] Efficient implementation of varying Dirichlet BCs when everything else in the system is constant

2016-08-19 Thread Wolfgang Bangerth
, 24, 25, 26 does this. Best Wolfgang -- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at

Re: [deal.II] Efficient implementation of varying Dirichlet BCs when everything else in the system is constant

2016-08-19 Thread Wolfgang Bangerth
n makes its way into deal.II itself -- with which we'd be happy to help!) Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.col

Re: [deal.II] Does MappingFEField apply to all cells ?

2016-08-22 Thread Wolfgang Bangerth
-- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum

Re: [deal.II] Does MappingFEField apply to all cells ?

2016-08-22 Thread Wolfgang Bangerth
. -- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum

[deal.II] Are you funded to write applications based on deal.II?

2016-08-22 Thread Wolfgang Bangerth
-- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/forum

Re: [deal.II] weakly enforcing an identity - vector mean curvature as the surface laplacian of the identity on a codim-1 manifold

2016-08-22 Thread Wolfgang Bangerth
nearOperator inverse_mass_matrix is not just an ordinary dealii::Matrix that I can then apply to dealii::Vectors. Well, is system_rhs nonzero? Best W. -- ---- Wolfgang Bangerth email: bange...@colostat

Re: [deal.II] Re: Data exchanges in IO

2016-08-23 Thread Wolfgang Bangerth
You may find the glossary entry linked to above useful, or maybe not. We would be quite happy to take any updated text if you find that it can be improved! Best W. -- Wolfgang Bangerth email: bange...@colostate.edu www: ht

Re: [deal.II] weakly enforcing an identity - vector mean curvature as the surface laplacian of the identity on a codim-1 manifold

2016-08-23 Thread Wolfgang Bangerth
there? (Maybe after rewriting it in such a way that you solve for all three components at once?) Cheers W. -- Wolfgang Bangerth email: bange...@colostate.edu www: http

Re: [deal.II] weakly enforcing an identity - vector mean curvature as the surface laplacian of the identity on a codim-1 manifold

2016-08-23 Thread Wolfgang Bangerth
ng this ( but it will have to wait until September), thank you for asking. That would be fantastic. Send me an off-list email when you are willing to go forward with this! Cheers W. -- ---- Wolfgang Bangerth email:

Re: [deal.II] Singular stiffness matrix when applying Dirichlet BC with constraint matrix

2016-08-24 Thread Wolfgang Bangerth
. You wouldn't use it for forming the product with your overall matrix in GMRES or whatever other method you use, but you'd use it when preconditioning. Best W. -- ---- Wolfgang Bangerth email:

Re: [deal.II] Some bug with deal.II from git

2016-08-24 Thread Wolfgang Bangerth
fgang -- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see

[deal.II] New video lectures

2016-08-24 Thread Wolfgang Bangerth
cated time stepping schemes I continue to be surprised how often these lectures are watched (collectively about 2,300 times per month). Keep it up, that's quite the motivation to keep recording more! Best Wolfgang -- ---

Re: [deal.II] Re: Reference article for modified Kelly Estimator

2016-08-24 Thread Wolfgang Bangerth
e: http://www.math.colostate.edu/~bangerth/videos.html Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.

Re: [deal.II] Re: Installation/Tutorial 1 Issue

2016-08-25 Thread Wolfgang Bangerth
all 'cmake .' * compile This should work. For your own project, you can copy one of the existing example directories somewhere else, then call cmake -DDEAL_II_DIR=/where/you/installed/dealii . and it should still work. Best W. -- -------

Re: [deal.II] Strange issue with KellyErrorEstimator functionality

2016-08-26 Thread Wolfgang Bangerth
x27;m afraid there is nothing we can help with from a distance without seeing the solution and/or the whole code... Cheers W. -- Wolfgang Bangerth email: bange...@colostat

Re: [deal.II] Re: Getting number of hanging support points

2016-08-26 Thread Wolfgang Bangerth
ult is pretty much what I think you probably wanted ;-) Cheers W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- Th

Re: [deal.II] Re: Getting number of hanging support points

2016-08-26 Thread Wolfgang Bangerth
On 08/26/2016 03:49 PM, Deepak GUpta wrote: Indeed Wolfgang is right. Can't help but respond with a smiley ;-) I'll count that as a win ahead of my weekend! Cheers W. -- ---- Wolfgang Bangerth

Re: [deal.II] Re: where and how should I use the MeshWorker class? how should I do to implement DG without MeshWorker?

2016-08-28 Thread Wolfgang Bangerth
use nobody knows any more how this works. It's really an unfortunate situation we got ourselves into with this small corner of the library. Best Wolfgang -- ---- Wolfgang Bangerth email:

Re: [deal.II] Re: assembling individual block step 43

2016-08-29 Thread Wolfgang Bangerth
minate the constraints you may have through other means.) You can of course see what variants of the make_sparsity_pattern function there are by looking here: https://www.dealii.org/8.4.1/doxygen/deal.II/namespaceDoFTools.html Best W. -- --

Re: [deal.II] Strange issue with KellyErrorEstimator functionality

2016-08-30 Thread Wolfgang Bangerth
. -- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https

Re: [deal.II] matrix factorization reuse?

2016-08-30 Thread Wolfgang Bangerth
fgang -- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/forum/d

Re: [deal.II] modify solution vector

2016-09-02 Thread Wolfgang Bangerth
::interpolate on v(x) to get the nodal values V of v_h(x), and then add V to your solution vector U. I think that ought to be easier than what you suggest (though internally it does exactly that). Best W. -- Wolfgang Bangerth

Re: [deal.II] Re: applying 3D mesh in step-20

2016-09-04 Thread Wolfgang Bangerth
ells. Is there anyway for me to show the inside of the calculated result to my boss? Use cutplanes, cutspheres, thresholds, etc., to cut away some cells while showing the others. Best Wolfgang -- ---- Wolfgan

Re: [deal.II] Re: singularity error due to 1/0

2016-09-05 Thread Wolfgang Bangerth
On 09/05/2016 06:29 AM, hanks0...@gmail.com wrote: Not theta=x/y in my code but theta=atan(x/y) You will at least want to use the atan2 function to prevent the division by zero here. Best W. -- Wolfgang Bangerth

Re: [deal.II] singularity error due to 1/0

2016-09-05 Thread Wolfgang Bangerth
s not. For example, for x=0, y=1, you have r=1 theta=pi/2 cos(theta)=0 K_inv[0,0] = 2/0 You need to think about what you want to do with this situation. Best W. -- ---- Wolfgang Bangerth ema

Re: [deal.II] merging geometries(geo files) in gmsh for computational geometry definition

2016-09-05 Thread Wolfgang Bangerth
cells resulting from meshing of the first cylinder and the second. I believe it is the problem, which causes program crashes. Can you describe how exactly it "crashes"? There are so many possibilities... Best W. -- ---- Wo

Re: [deal.II] Re: Creating my own constraints matrix for applying dirichlet bc

2016-09-05 Thread Wolfgang Bangerth
. -- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https

Re: [deal.II] merging geometries(geo files) in gmsh for computational geometry definition

2016-09-05 Thread Wolfgang Bangerth
o talk to the people who wrote gmsh what this is supposed to mean. Best Wolfgang -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~ban

Re: [deal.II] Doubt regarding constraints

2016-09-06 Thread Wolfgang Bangerth
, both need to know about it. Q3. What happens when the processor 2 calls the same thing but in the other order ? Bad things. Don't do it :-) Best Wolfgang -- Wolfgang Bangerth email:

Re: [deal.II] Applying Multi Point Constraints

2016-09-07 Thread Wolfgang Bangerth
way is the result wrong? Best Wolfgang -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/

Re: [deal.II] Re: Failing to set up simple test configuration

2016-09-07 Thread Wolfgang Bangerth
ize.pl VERBATIM ) We here call "perl -pi ". Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at http://www.dealii.org/ For mailing

Re: [deal.II] Applying Multi Point Constraints

2016-09-07 Thread Wolfgang Bangerth
or on which both these two dofs lie. Am I right here ? Correct. W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located a

Re: [deal.II] Problem creating a pull request on code-gallery

2016-09-08 Thread Wolfgang Bangerth
o create a pull request from your code-gallery fork against the code-gallery master repository. Does this help? Cheers W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu

Re: [deal.II] After the calculation, Can the result be used??

2016-09-09 Thread Wolfgang Bangerth
have to be more specific. Best W. -- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at

Re: [deal.II] singularity error due to 1/0

2016-09-09 Thread Wolfgang Bangerth
imply nothing you can do about this -- it's not a question how you *compute* it, it's that that's what the *model* says. If you don't like it, you need to start thinking about whether that's the *correct model*! Best W. -- --

Re: [deal.II] How to declare a constant that is used in a template?

2016-09-10 Thread Wolfgang Bangerth
ook at the main() function of ASPECT, for example: https://github.com/geodynamics/aspect/blob/master/source/main.cc lines 452-490. Best Wolfgang -- ---- Wolfgang Bangerth email: bange..

Re: [deal.II] Help with Vector template instantiations

2016-09-10 Thread Wolfgang Bangerth
in the .inst file, which is #included in the .cc file. Best Wolfgang -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The

  1   2   3   4   5   6   7   8   9   10   >