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

2016-09-10 Thread Wolfgang Bangerth
ght solution. Want to try writing a patch for this? We'd be happy to merge it! Best Wolfgang -- ---- Wolfgang Bangerth email: bange...@colostate.edu w

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

2016-09-10 Thread Wolfgang Bangerth
ks! 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.google.com/d/forum/deal

Re: [deal.II] Doubt with data output in parallel

2016-09-14 Thread Wolfgang Bangerth
->is_locally_owned) data_array(index)=value; | or | for(;cell!=endc,++cell) if(cell->is_locally_owned()) data_array(cell->active_cell_index())=value; | Both will work. They are identical. Best W. --

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

2016-09-14 Thread Wolfgang Bangerth
just say so, and that's ok with me as well. Best Wolfgang -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- T

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

2016-09-14 Thread Wolfgang Bangerth
oftware are fully coupled and the boundary conditions can be set using the equations from the other software etc. That would make for a fantastic code gallery project! Best Wolfgang -- ---- Wolfgang Bangerth email:

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

2016-09-16 Thread Wolfgang Bangerth
gang -- ---- 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/f

Re: [deal.II] Why is this asserted to be impossible?

2016-09-17 Thread Wolfgang Bangerth
ated? 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.google.com/d/

Re: [deal.II] A*diag(V) with mmult?

2016-09-18 Thread Wolfgang Bangerth
eved using the Vector::scale() function. Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is

Re: [deal.II] Re: Can we say that the higher order method, the more accurate?

2016-09-18 Thread Wolfgang Bangerth
become very dense and difficult to invert. Best W. -- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is

Re: [deal.II] Re: Can we say that the higher order method, the more accurate?

2016-09-18 Thread Wolfgang Bangerth
re. You can't expect a high accuracy for a boundary integral if the boundary is not accurately represented. Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu

Re: [deal.II] Why is this asserted to be impossible?

2016-09-18 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] Interpolating values of the neighbor cells in DG

2016-09-19 Thread Wolfgang Bangerth
st 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/ For mailing list/forum options, see https://groups.google.com/d/forum/

Re: [deal.II] Interpolating values of the neighbor cells in DG

2016-09-19 Thread Wolfgang Bangerth
st 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

Re: [deal.II] VectorTools::integrate_difference function

2016-09-20 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/dealii

Re: [deal.II] Could not find LAPACK library

2016-09-22 Thread Wolfgang Bangerth
ystem? 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 opti

Re: [deal.II] Re: Calculate surface integral over a boundary

2016-09-23 Thread Wolfgang Bangerth
ed: https://github.com/geodynamics/aspect/blob/master/source/postprocess/heat_flux_statistics.cc#L122 It loops over all faces and then over the quadrature points of each face. Best W. -- ---- Wolfgang Bangerth

Re: [deal.II] Re: Calculate surface integral over a boundary

2016-09-23 Thread Wolfgang Bangerth
time? 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 opti

Re: [deal.II] What are Deal.II killer features when comparing against Comsol?

2016-09-25 Thread Wolfgang Bangerth
, send an email to dealii+unsubscr...@googlegroups.com <mailto:dealii+unsubscr...@googlegroups.com>. For more options, visit https://groups.google.com/d/optout. -- ---- Wolfgang Bangerth email:

Re: [deal.II] Re: Loading DoFHandler from Archive

2016-09-25 Thread Wolfgang Bangerth
r more options, visit https://groups.google.com/d/optout. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is

Re: [deal.II] Hanging node constraints

2016-09-27 Thread Wolfgang Bangerth
all, self-contained testcase that shows the problem? Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at htt

Re: [deal.II] Hanging node constraints

2016-09-27 Thread Wolfgang Bangerth
ke it smaller and smaller until the issue goes away. The part that you removed last was then the offending statement. Put it back in, and that is your minimal testcase. Best W. -- ---- Wolfgang Bangerth ema

Re: [deal.II] Hanging node constraints

2016-09-27 Thread Wolfgang Bangerth
there can be no neighbor) and so no constraints will be computed. Best W. -- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth

Re: [deal.II] Hanging node constraints

2016-09-27 Thread Wolfgang Bangerth
On 09/27/2016 10:12 AM, Deepak Gupta wrote: Thanks, after this explanation, it sounds extremely silly on my side :) You're not the first one to make this mistake. W. -- Wolfgang Bangerth

Re: [deal.II] Hanging node constraints

2016-09-27 Thread Wolfgang Bangerth
would be a worthwhile project. 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 http

Re: [deal.II] Derivatives (gradients) of Symmetric Tensors

2016-09-29 Thread Wolfgang Bangerth
ors (Vector::symmetric_gradient), or point out any material (manual, video etc.)? Can you be more specific which functions and which parts within them you have trouble with? Best Wolfgang -- ---- Wolfgang Bangerth email:

Re: [deal.II] Relation between Solution Error Behavior and Polynomial Approximation Degree

2016-09-29 Thread Wolfgang Bangerth
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.google.com/d/fo

Re: [deal.II] Neumann bc in step-20

2016-09-29 Thread Wolfgang Bangerth
ause the Raviart-Thomas element mixes both the x- and y-components of the velocity vector. I think you should be able to use VectorTools::project_boundary_values_div_conforming instead to do what you want to do. Best W. -- ------

Re: [deal.II] Parallel hp::DoFHandler

2016-09-30 Thread Wolfgang Bangerth
ss. 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/ For mailing list/forum options, see https:/

Re: [deal.II] FEValues and get_function_values when support points = quadrature points

2016-09-30 Thread Wolfgang Bangerth
case? 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.o

Re: [deal.II] FEValues and get_function_values when support points = quadrature points

2016-09-30 Thread Wolfgang Bangerth
go through to make this work in all generality :-) Best W. -- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The

Re: [deal.II] Function parser error

2016-10-03 Thread Wolfgang Bangerth
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/ For mailing list/forum options, see https://groups.google.com/d/forum/deali

Re: [deal.II] how to use solution.

2016-10-04 Thread Wolfgang Bangerth
ction. Several example programs use it, so you will find use cases there. Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~ban

Re: [deal.II] Issue with Trilinos installation (issue with blas?)

2016-10-04 Thread Wolfgang Bangerth
-l' instead? 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 lis

Re: [deal.II] Re: Issue with Trilinos installation (issue with blas?)

2016-10-04 Thread Wolfgang Bangerth
specific reason for that recommendation, Wolfgang?) No, it will work with any reasonably new version of Trilinos. Go with the latest one. Best W. -- Wolfgang Bangerth email: bange

Re: [deal.II] Re: Issue with Trilinos installation (issue with blas?)

2016-10-04 Thread Wolfgang Bangerth
f you had a small program that contained nothing but int main() {} and which you compile via c++ test.cc -l/usr/lib64/libblas.so.3.6.1 ? What if this program contained a call to a BLAS function? Best Wolfgang -- Wol

Re: [deal.II] Re: Issue with Trilinos installation (issue with blas?)

2016-10-05 Thread Wolfgang Bangerth
ge manager until you figure this out. At least you now have a small testcase. Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu

Re: [deal.II] Using p-refinement with high order elements

2016-10-05 Thread Wolfgang Bangerth
a field (with sufficiently high n_subdivisions passed to DataOut::build_patches()). Best W. -- Wolfgang Bangerth email: bange...@colostate.edu www: http

Re: [deal.II] Re: Running deal.ii with METIS

2016-10-05 Thread Wolfgang Bangerth
omatic partitioning in step-18. But in any case, even the automatic partitioning relies on METIS if you run it in parallel. Best W. -- ---- Wolfgang Bangerth email: bange...@colosta

Re: [deal.II] Using p-refinement with high order elements

2016-10-06 Thread Wolfgang Bangerth
obal, not cell->distribute_local_to_gobal, right? Meanwhile I am going to extend the simple example for a basic version of the elastic problem I am trying to solve. Hope then I can figure out the error. Good plan. Best W. -- ---

Re: [deal.II] How to solve for the null space of system matrix?

2016-10-10 Thread Wolfgang Bangerth
rix may be indefinite, and CG can not solve it. Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II

Re: [deal.II] How to solve for the null space of system matrix?

2016-10-10 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] How to solve for the null space of system matrix?

2016-10-10 Thread Wolfgang Bangerth
CG may not converge. Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at http://www.

Re: [deal.II] How to solve for the null space of system matrix?

2016-10-10 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/dealii?hl=en --- You

Re: [deal.II] Solution Components of a Vector valued problem

2016-10-13 Thread Wolfgang Bangerth
things are as you describe. 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] Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range

2016-10-14 Thread Wolfgang Bangerth
re complicated recently. 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.google

Re: [deal.II] Re: How to use Trilinos instead of Petsc in step-40

2016-10-16 Thread Wolfgang Bangerth
t the problem is, and then fix it the right way. Don't paper over it. Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangert

Re: [deal.II] Re: How to use Trilinos instead of Petsc in step-40

2016-10-18 Thread Wolfgang Bangerth
s not* s.p.d. Using a different solver might allow you to solve the linear system, but since the linear system is apparently not the correct one, the solution will also not be correct. Best W. -- Wolfgang Bangerth

Re: [deal.II] Re: Easy way to calculate second-deviatoric tensor

2016-10-18 Thread Wolfgang Bangerth
uted, then Pi_gamma = std::sqrt (2*eps*eps); Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is

Re: [deal.II] Re: constitutive model for soil

2016-10-18 Thread Wolfgang Bangerth
https://github.com/dealii/dealii/issues/3091 Best Wolfgang -- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II proje

Re: [deal.II] Re: Defining tensor in different dim and spacedim

2016-10-19 Thread Wolfgang Bangerth
l you need to do at the symmetry axis. Best W. -- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II proje

Re: [deal.II] Some questions on Nonlinear Problems

2016-10-20 Thread Wolfgang Bangerth
hieve O(h^p), you will of course have to ensure that the iteration error also becomes smaller and smaller as you refine the mesh, i.e., you have to reduce the Newton tolerance with every mesh refinement. Best W. -- ----

[deal.II] Development history of deal.II

2016-10-20 Thread Wolfgang Bangerth
today than in the early days! Enjoy! W. -- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located

Re: [deal.II] Re: How to use Trilinos instead of Petsc in step-40

2016-10-20 Thread Wolfgang Bangerth
a previous email, you ought to make sure that the matrix you build is the matrix you *want* to build. Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu

Re: [deal.II] Re: Defining tensor in different dim and spacedim

2016-10-20 Thread Wolfgang Bangerth
on of type ‘dealii::Triangulation<3, 3>’ You pass a 3d triangulation to a function that expects a 2d-triangulation-embedded-into-3d-space as argument. Which function are you trying to call? Best W. -- ---- Wolfgang Bangert

Re: [deal.II] Re: How to use Trilinos instead of Petsc in step-40

2016-10-21 Thread Wolfgang Bangerth
On Thursday, October 20, 2016 at 9:48:55 PM UTC-5, Wolfgang Bangerth wrote: What is the norm of the first right hand side? You now set the tolerance in the first iteration to a fixed value of 1e-16, but how does this compare to the previous value of 1e-12*system_rhs.l2_norm

Re: [deal.II] question on contact algorithm for step-41

2016-10-21 Thread Wolfgang Bangerth
you wanted to try this, we'd be very happy to take your program and incorporate it into the tutorial or the code gallery! Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu

Re: [deal.II] Re: Development history of deal.II

2016-10-22 Thread Wolfgang Bangerth
rs 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.google.com/d/

Re: [deal.II] Re: How to use sacado package

2016-10-22 Thread Wolfgang Bangerth
viously have to have MPI installed on your system. You have two options: You can either install the MPI package on your machine, or you can tell Trilinos not to use MPI. That choice is yours. Best W. -- ---- Wolfgang Bangerth

Re: [deal.II] Re: How to use Trilinos instead of Petsc in step-40

2016-10-22 Thread Wolfgang Bangerth
symmetric. Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at http://www.deali

Re: [deal.II] Alternative to local_range

2016-10-22 Thread Wolfgang Bangerth
that returns an IndexSet that contains all of the elements locally stored. Best W. -- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu

Re: [deal.II] Re: How to apply boundary values for a particular point on the boundary instead of the whole boundary surface

2016-10-26 Thread Wolfgang Bangerth
o keep two meshes around. Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is locat

Re: [deal.II] Re: boundary conditions

2016-10-26 Thread Wolfgang Bangerth
only determined up to a constant). What you are asking is whether the prescribed boundary condition makes sense *physically*, but that is a separate question. Best W. -- Wolfgang Bangerth email

Re: [deal.II] post processing a vector valued solution

2016-10-26 Thread Wolfgang Bangerth
is functionality, and we'd be happy to walk you through it.) Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is

Re: [deal.II] How to addapt MappingQEulerian class for Parallel codes using the PETSc wrapper classes

2016-10-26 Thread Wolfgang Bangerth
entation of programs such as step-40 to understand which elements of a parallel vector are stored on each processor. Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu

Re: [deal.II] post processing a vector valued solution

2016-10-27 Thread Wolfgang Bangerth
alii/issues/391 See the second comment there. It *should* be a vector of Tensor<1,dim>, but it's not, unfortunately :-( Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu

Re: [deal.II] Re: post processing a vector valued solution

2016-10-27 Thread Wolfgang Bangerth
you traverse the cells, one element per cell. You can use that for further computations. You can even pass this vector to DataOut. Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu

Re: [deal.II] Deal.ii works on Linux subsystem in Windows 10

2016-10-27 Thread Wolfgang Bangerth
st work because it can use cmake's Makefile generator in the Eclipse project. Best W. -- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The de

Re: [deal.II] Re: boundary conditions

2016-10-28 Thread Wolfgang Bangerth
is not periodic. 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] Multiplie mpi instances of code

2016-10-28 Thread Wolfgang Bangerth
only one rank. What happens if you output from rank 1? Do you get any output at all? Best W. -- Wolfgang Bangerth email: bange...@colostate.edu www: http

Re: [deal.II] Imposing distributed pressure on the curved edge of a circle(sphere in 3D)

2016-10-28 Thread Wolfgang Bangerth
he implementation of the quarter circle to see how this is done! 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.o

Re: [deal.II] Multiplie mpi instances of code

2016-10-28 Thread Wolfgang Bangerth
le? 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 op

Re: [deal.II] Multiplie mpi instances of code

2016-10-28 Thread Wolfgang Bangerth
will also need to be recompiled then ? I don't know. You say that it suddenly stopped working. Did it work correctly before? What has changed in the meantime? Best W. -- Wolfgang Bangerth

Re: [deal.II] Multiplie mpi instances of code

2016-10-28 Thread Wolfgang Bangerth
st 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 op

Re: [deal.II] computing some other output quantity after solution is calculated.

2016-10-31 Thread Wolfgang Bangerth
p the projection and use the DataPostprocessor class instead. This is certainly more efficient than what you do right now. Best W. -- Wolfgang Bangerth email: bange...@colostat

Re: [deal.II] mesh generation for arbitrary boundary

2016-10-31 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] computing some other output quantity after solution is calculated.

2016-10-31 Thread Wolfgang Bangerth
nd sample the solution at these points to get upper bounds for the minimum, and lower bounds for the maximum of the solution function u_h(x). Best W. -- ---- Wolfgang Bangerth email: bange...@

Re: [deal.II] computing some other output quantity after solution is calculated.

2016-10-31 Thread Wolfgang Bangerth
. 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.google.c

Re: [deal.II] Re: hp convergence for non-linear solver.

2016-11-02 Thread Wolfgang Bangerth
On 11/01/2016 11:06 PM, Jaekwang Kim wrote: do you have any other idea? Output the errors per cell and visualize. Is there a pattern? Is the error localized on the boundary, for example? Best W. -- Wolfgang

Re: [deal.II] Re: Convergence problem arising for large number of DoFs

2016-11-02 Thread Wolfgang Bangerth
st 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

Re: [deal.II] Absolute values of deal.II vector

2016-11-02 Thread Wolfgang Bangerth
On 11/02/2016 07:06 AM, hanks0...@gmail.com wrote: Anyway, what I'm trying to do is to get error = |exact_solution - numerical_solution| (absolute value of two Deal.II Vector) and then plot this one using Visit. But I don't know how to change all elements of error(Deal.II Vector) to absolute va

Re: [deal.II] Changing geometry

2016-11-02 Thread Wolfgang Bangerth
herewith. My question would be: how do you determine whether you have the correct/wrong solution? What do you compare with? Best W. -- Wolfgang Bangerth email: bange...@colostate.edu

Re: [deal.II] Re: hp convergence for non-linear solver.

2016-11-02 Thread Wolfgang Bangerth
that to the DataOut object you have. step-27 shows how to do that, but it in essence works just like for vectors that have as many entries as there are DoFs. Best W. -- Wolfgang Bangerth email:

Re: [deal.II] GridGeneration

2016-11-02 Thread Wolfgang Bangerth
n of step-6. Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at http://www.d

Re: [deal.II] Postprocessing output of TensorFunction<1,dim>

2016-11-03 Thread Wolfgang Bangerth
to the "Possibilities for extensions" of one of the tutorials. Want to give this a try and see whether you can come up with some code that does that? Cheers W. -- ---- Wolfgang Bangerth email:

Re: [deal.II] Re: Problems in handling the userdata of Distributed Triangulation

2016-11-03 Thread Wolfgang Bangerth
ather the information on cells that are ghosts on some other processor, and then send this information to all relevant processors. Best W. -- Wolfgang Bangerth email: bange...@colostat

Re: [deal.II] DWARF version?

2016-11-04 Thread Wolfgang Bangerth
On 11/04/2016 07:50 AM, Victor Eijkhout wrote: You guys don’t run into problems with trilinos? No, I install it all the time. It may be that we don't because we don't usually use STK... Best W. -- ---- Wolfgan

Re: [deal.II] DWARF version?

2016-11-04 Thread Wolfgang Bangerth
already. 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

Re: [deal.II] Re: using .vtk file as initial condition

2016-11-06 Thread Wolfgang Bangerth
dynamics/aspect/blob/master/source/simulator/checkpoint_restart.cc This is of course a much larger project, but it may still help you understand how things are used in practice. Best W. -- ---- Wolfgang Bangerth email:

Re: [deal.II] deal.II on youtube and twitter

2016-11-07 Thread Wolfgang Bangerth
t is true for everyone, not just you! These accounts could use more activity :-) Cheers W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colosta

Re: [deal.II] Re: using .vtk file as initial condition

2016-11-07 Thread Wolfgang Bangerth
:-) 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] Re: Question about Step 44 shape function gradient computations

2016-11-08 Thread Wolfgang Bangerth
ar to others. 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 mailing list/forum options, see https://groups.google.com/d/fo

Re: [deal.II] Re: using .vtk file as initial condition

2016-11-08 Thread Wolfgang Bangerth
riangulation and all nodal and element information. How to go about it? That is where you should use the boost serialization functionality others have already pointed you to. Best W. -- ---- Wolfgang Bangerth

Re: [deal.II] How to use a function avoiding to pass some of its arguments

2016-11-08 Thread Wolfgang Bangerth
nts in setup_system? 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 l

Re: [deal.II] How to use a function avoiding to pass some of its arguments

2016-11-08 Thread Wolfgang Bangerth
. That said, you *do* need to apply boundary values in subsequent Newton iterations. They just have to be zero displacement. Take a look at step-15. Best W. -- Wolfgang Bangerth email: bange

Re: [deal.II] Re: Convergence problem arising for large number of DoFs

2016-11-08 Thread Wolfgang Bangerth
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/ F

Re: [deal.II] small issues with assembly

2016-11-09 Thread Wolfgang Bangerth
in between? Best W. -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located at http://www.deali

Re: [deal.II] small issues with assembly

2016-11-09 Thread Wolfgang Bangerth
? 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/for

Re: [deal.II] Re: Convergence problem arising for large number of DoFs

2016-11-09 Thread Wolfgang Bangerth
them? I believe so -- there should be iterators for that. In parallel, you can of course only iterate over elements that are stored locally on a processor. Best W. -- Wolfgang Bangerth email

Re: [deal.II] Cluster with Infiniband network

2016-11-09 Thread Wolfgang Bangerth
this is a symptom of a lose cable or a wrong configuration of the MPI system -- both things we have seen in cluster in the past. Best W. -- Wolfgang Bangerth email: bange...@colostat

Re: [deal.II] Re: Interfacing dealii-8.4.1 with trilinos-12.6.2 - make test failed

2016-11-09 Thread Wolfgang Bangerth
II. This is not going to work. Best W> -- ---- Wolfgang Bangerth email: bange...@colostate.edu www: http://www.math.colostate.edu/~bangerth/ -- The deal.II project is located

<    1   2   3   4   5   6   7   8   9   10   >