Re: [deal.II] step-42 now available

2020-04-01 Thread Muhammad Mashhood
Hi Mac,
 I really appreciate your concern and thank you for nice and 
brief summary regarding classical plasticity algorithm. 
I would like to highlight here that in Prisms-plasticity this algorithm is 
also implemented but I checked with its continuum plasticity application, 
which so far is not updated and hence also the code is not working for 
continuum plasticity part. As per communication from developers they will 
update and make it run in next update.
Secondly I am preferably using the step-42. Personally for me it seems bit 
simpler and I already coupled it with other physics for multi-physics 
problem.


On Wednesday, April 1, 2020 at 11:26:44 AM UTC+2, mac wrote:
>
> Hi all 
>
> Classical plasticity is underpinned by return mapping algorithms that 
> operate at the level of the quadrature point. One has a global predictor 
> for the displacement field where we assume frozen plastic flow. Then at 
> each quadrature point you compute a trial strain, and hence a trial stress. 
> The trial stress is used to test for yield at the quadrature point. You 
> then compute the plastic multiplier, and hence the plastic strain, to 
> return to the yield surface. This is an iterative process at the global and 
> possibly local level.
>
No doubt, you are very right that the plastic multiplier is evaluated in 
iterative manner and this very plastic multiplier is then a key to plastic 
strain evaluation. But here I would like to highlight that in the step-42 
seemingly a bit different method is used to solve elastoplastic problem. As 
far as I could understand the algorithm in hand, here after evaluating the 
trial stress in terms of Von-Mises equivalent stress and also when it is 
higher than the yield stress, the stiffness tensor is evaluated as function 
of current trial stress. After that this very stiffness tensor is used to 
evaluate displacement and strain increments and convergence of Newton 
algorithm is checked. So in this way the system is solved iteratively and 
after convergence the displacement and the total strain is present as 
output. 
As the total strain is the output that is why I need here some way to 
evaluate the plastic and elastic strain (any one of them so that other can 
be evaluated from additive decomposition). If you want, you can check this 
interesting and simple algorithm in a deal.ii step-42 code or this nice 
article of "Goal oriented error estimation and mesh adaptivity in 3d 
elastoplasticity problems" doi: 
https://doi-org.proxy.bnl.lu/10.1007/s10704-016-0113-y 

I hope I explained it well. Thanks again for showing interest and your 
concern. 

>
> All of this can and has been done in deal.ii. Wolfgang has suggested using 
> CellDataStorage which will allow you to handle the quadrature point data. 
> For implementations have a look at 
> https://github.com/prisms-center/plasticity . 
>
> You might also want to have a look at some of the extensive literature 
> e.g. https://onlinelibrary.wiley.com/doi/book/10.1002/9780470694626 Here 
> they explain the algorithm in detail.
>
> Best
> A
>
> On 30 Mar 2020, at 19:09, Muhammad Mashhood  > wrote:
>
>
>
> On Monday, February 24, 2020 at 12:42:17 AM UTC+1, Wolfgang Bangerth wrote:
>>
>>
>> > In my question I meant whether is it possible to evaluated plastic 
>> strain 
>> > component from currently implemented plasticity algorithm as a further 
>> > development of this code? 
>>
>> I am pretty sure that it is, by just computing the difference between the 
>> elastic stress (C eps(u)) and the actual stress computed. In fact, for 
>> the 
>> current situation, the actual stress computed equal to the elastic stress 
>> where it is less than the yield stress (and so the plastic strain is 
>> zero), 
>> and it is simply a fraction of the elastic stress where it exceeds the 
>> yield 
>> stress. Once you have the plastic stress, you can compute the plastic 
>> strain 
>> by multiplying it by C^{-1}. 
>> Thank you very much Prof. Wolfgang for your suggestion and I hope you are 
>> doing all well. As far as I understood now from your suggestion is that on 
>> the base of additive decomposition, I can subtract elastic stress (C 
>> eps(u)) from the actual stress computed to have the plastic stress part. 
>> But here I just noticed in the program that we also need (eps(u)) or the 
>> elastic strain part to have elastic stress part's value when the domain is 
>> in the plastic region.
>
> In one dimension problem there is I think no problem because from 
> stress strain curve one knows already the elastic stress value (which is 
> yield stress) but here we have multidimensional problem i.e. stress and 
> strain as a 2nd order tensor. Therefore I am 

Re: [deal.II] step-42 now available

2020-04-01 Thread Andrew McBride
Hi all 

Classical plasticity is underpinned by return mapping algorithms that operate 
at the level of the quadrature point. One has a global predictor for the 
displacement field where we assume frozen plastic flow. Then at each quadrature 
point you compute a trial strain, and hence a trial stress. The trial stress is 
used to test for yield at the quadrature point. You then compute the plastic 
multiplier, and hence the plastic strain, to return to the yield surface. This 
is an iterative process at the global and possibly local level.

All of this can and has been done in deal.ii. Wolfgang has suggested using 
CellDataStorage which will allow you to handle the quadrature point data. For 
implementations have a look at https://github.com/prisms-center/plasticity 
 . 

You might also want to have a look at some of the extensive literature e.g. 
https://onlinelibrary.wiley.com/doi/book/10.1002/9780470694626 
 Here they 
explain the algorithm in detail.

Best
A

> On 30 Mar 2020, at 19:09, Muhammad Mashhood  wrote:
> 
> 
> 
> On Monday, February 24, 2020 at 12:42:17 AM UTC+1, Wolfgang Bangerth wrote:
> 
> > In my question I meant whether is it possible to evaluated plastic strain 
> > component from currently implemented plasticity algorithm as a further 
> > development of this code? 
> 
> I am pretty sure that it is, by just computing the difference between the 
> elastic stress (C eps(u)) and the actual stress computed. In fact, for the 
> current situation, the actual stress computed equal to the elastic stress 
> where it is less than the yield stress (and so the plastic strain is zero), 
> and it is simply a fraction of the elastic stress where it exceeds the yield 
> stress. Once you have the plastic stress, you can compute the plastic strain 
> by multiplying it by C^{-1}. 
> Thank you very much Prof. Wolfgang for your suggestion and I hope you are 
> doing all well. As far as I understood now from your suggestion is that on 
> the base of additive decomposition, I can subtract elastic stress (C eps(u)) 
> from the actual stress computed to have the plastic stress part. But here I 
> just noticed in the program that we also need (eps(u)) or the elastic strain 
> part to have elastic stress part's value when the domain is in the plastic 
> region.
> In one dimension problem there is I think no problem because from stress 
> strain curve one knows already the elastic stress value (which is yield 
> stress) but here we have multidimensional problem i.e. stress and strain as a 
> 2nd order tensor. Therefore I am thinking now that how this elastic strain 
> tensor can be evaluated to have elastic stress part to be subtracted from 
> total calculated stress. 
> One of the idea I have so far is to use the calculated "strain_tensor" to 
> find the elastic stress as  "elastic_stress_tensor = 
> (stress_strain_tensor_kappa + stress_strain_tensor_mu) * strain_tensor". But 
> again the point is that the "strain_tensor" here is the total strain rather 
> than elastic strain component.  
> 
> Kindly correct me if I misunderstood your suggestion at any point or if there 
> is an alternate approach possible. Thank you again in advance. 
> Stay healthy stay safe!
> 
> 
> > Then as a step further I would be trying to store this plastic strain in 
> > cells 
> > or Gauss points along with the modified yield strength (due to isotropic 
> > hardening) so that history of loading is stored too in the domain. 
> 
> I imagine that that, too, can be done. I'm not an expert in plasticity, but I 
> see no fundamental reasons why what you want to do should not be possible. 
> There are also classes CellDataStorage and TransferableQuadraturePointData 
> and 
> parallel::distributed::ContinuousQuadratureDataTransfer that can help you 
> with 
> storing information at quadrature points. 
> 
> Best 
>   W. 
> 
> -- 
>  
> Wolfgang Bangerth  email: bang...@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 received this message because you are subscribed to the Google Groups 
> "deal.II User Group" group.
> To unsubscribe from this group and stop receiving emails from it, send an 
> email to dealii+unsubscr...@googlegroups.com 
> .
> To view this discussion on the web visit 
> https://groups.google.com/d/msgid/dealii/9a59d3e4-e11d-4f6e-af92-c34c85fe9b57%40googlegroups.com
>  
> 

Re: AW: [deal.II] step-42 clarification

2018-02-05 Thread Timo Heister
> In such a case, one wants to restart the computations

We have support for snapshot in parallel with adaptive meshes
by using the SolutionTransfer class. See "Use for serialization" in
https://urldefense.proofpoint.com/v2/url?u=http-3A__www.dealii.org_developer_doxygen_deal.II_classparallel-5F1-5F1distributed-5F1-5F1SolutionTransfer.html=DwIBaQ=Ngd-ta5yRYsqeUsEDgxhcqsYYY1Xs5ogLxWPA_2Wlc4=4k7iKXbjGC8LfYxVJJXiaYVu6FRWmEjX38S7JmlS9Vw=88KR9zh1f_gaVgWHpZwwXXlaOCduKgZ1yzsuERztdmU=Q549G3WmW1DtS06Yq9GyH98gIg8Rl44Ezac7I1Fc1Tc=
 

You can also check out how we do things in ASPECT:
https://urldefense.proofpoint.com/v2/url?u=https-3A__github.com_geodynamics_aspect_blob_master_source_simulator_checkpoint-5Frestart.cc=DwIBaQ=Ngd-ta5yRYsqeUsEDgxhcqsYYY1Xs5ogLxWPA_2Wlc4=4k7iKXbjGC8LfYxVJJXiaYVu6FRWmEjX38S7JmlS9Vw=88KR9zh1f_gaVgWHpZwwXXlaOCduKgZ1yzsuERztdmU=cUF_2LwSAUqoivqPWcoBBBpepBLrCfq8fDSkWlrkBTY=
 

-- 
Timo Heister
http://www.math.clemson.edu/~heister/

-- 
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 received this message because you are subscribed to the Google Groups 
"deal.II User Group" group.
To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.


Re: AW: [deal.II] step-42 clarification

2018-01-26 Thread Alberto Salvadori
Thank you, Timo. Your remarks have been very useful.
It turned out that I made a mistake in the way the mesh was prepared,
 specifically some hanging nodes were not properly dealt with.
This caused also a related issue, that I shared here some time ago (Nov.
25).

This leads to another question, that I take the opportunity to ask. Suppose
that a run is too long for a time slot allocated on a large scale computer.
In such a case, one wants to restart the computations
from a given time. To this aim, the history of the computations up to a
certain time shall be stored. All data stored in cell->user_pointer(), data
of the loads and mesh.
How can one store information on the latter, - as for the partition and the
hanging nodes - correctly? I understand that saving the mesh in a "ucd" or
alternative form may not be the right strategy.

Thank you very much.
Alberto








*Alberto Salvadori* Dipartimento di Ingegneria Civile, Architettura,
Territorio, Ambiente e di Matematica (DICATAM)
 Universita` di Brescia, via Branze 43, 25123 Brescia
 Italy
 tel 030 3711239
 fax 030 3711312

e-mail:
 alberto.salvad...@unibs.it
web-pages:
 http://m4lab.unibs.it/faculty.html
 http://dicata.ing.unibs.it/salvadori

On Fri, Jan 19, 2018 at 3:39 PM, Timo Heister  wrote:

> > in the code and re-implemented it. In serial version, all works fine so
> far.
> > However, when running in parallel, I am seeing an issue in the method
> > PlasticityContactProblem::update_solution_and_constraints.
> >
> > In particular, it turns out that the value of
> >
> > const unsigned int index_z = dof_indices[q_point];
> >
> > might be out of the range of
>
> If you do a loop over all locally owned and locally relevant cells
> than all dof values of a ghosted vector should exist. If you see an
> error, something else must be incorrect (like the IndexSets).
>
> >   PETScWrappers::MPI::Vector lambda( this->locally_relevant_dofs,
> this->mpi_communicator);
>
> This looks suspicious. Does this really create a ghosted vector in
> PETSc? I thought this would fail (at least in debug mode).
>
> Finally, it looks like you modified it to only look at locally owned
> cells to build constraints. The problem with this is that processors
> also need to know about constraints on ghost cells, not only locally
> owned cells. You no longer compute them, which means the solution
> might become incorrect around processor boundaries. It probably
> (hopefully?) works without adaptivity because each locally owned DoF
> is within at least one locally owned cell, but imagine a case where a
> dof on a ghost cells is constrained and interacts with a hanging node
> the current processor owns. You will not handle this case correctly.
>
> I don't quite remember if there is an easy way to do this, but I
> remember writing a debug function that checks if a ConstraintMatrix is
> consistent in parallel. This was a while back, but I can try to find
> it.
>
> --
> Timo Heister
> http://www.math.clemson.edu/~heister/
>
> --
> 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 received this message because you are subscribed to the Google Groups
> "deal.II User Group" group.
> To unsubscribe from this group and stop receiving emails from it, send an
> email to dealii+unsubscr...@googlegroups.com.
> For more options, visit https://groups.google.com/d/optout.
>

-- 

Informativa sulla Privacy: http://www.unibs.it/node/8155

-- 
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 received this message because you are subscribed to the Google Groups 
"deal.II User Group" group.
To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.


Re: AW: AW: [deal.II] step-42 clarification

2018-01-22 Thread Wolfgang Bangerth



I can do that for you. Do I understand correctly that the only change
that needs to happen is to move
   active_set_old = active_set;
to *after* the if-statement?


Exactly.


Great, thanks for confirming, Joerg!

The patch is now here:
  https://www.dealii.org/8.5.1/doxygen/deal.II/Tutorial.html

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/forum/dealii?hl=en
--- 
You received this message because you are subscribed to the Google Groups "deal.II User Group" group.

To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.


Re: AW: [deal.II] step-42 clarification

2018-01-19 Thread Timo Heister
> in the code and re-implemented it. In serial version, all works fine so far.
> However, when running in parallel, I am seeing an issue in the method
> PlasticityContactProblem::update_solution_and_constraints.
>
> In particular, it turns out that the value of
>
> const unsigned int index_z = dof_indices[q_point];
>
> might be out of the range of

If you do a loop over all locally owned and locally relevant cells
than all dof values of a ghosted vector should exist. If you see an
error, something else must be incorrect (like the IndexSets).

>   PETScWrappers::MPI::Vector lambda( this->locally_relevant_dofs, 
> this->mpi_communicator);

This looks suspicious. Does this really create a ghosted vector in
PETSc? I thought this would fail (at least in debug mode).

Finally, it looks like you modified it to only look at locally owned
cells to build constraints. The problem with this is that processors
also need to know about constraints on ghost cells, not only locally
owned cells. You no longer compute them, which means the solution
might become incorrect around processor boundaries. It probably
(hopefully?) works without adaptivity because each locally owned DoF
is within at least one locally owned cell, but imagine a case where a
dof on a ghost cells is constrained and interacts with a hanging node
the current processor owns. You will not handle this case correctly.

I don't quite remember if there is an easy way to do this, but I
remember writing a debug function that checks if a ConstraintMatrix is
consistent in parallel. This was a while back, but I can try to find
it.

-- 
Timo Heister
http://www.math.clemson.edu/~heister/

-- 
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 received this message because you are subscribed to the Google Groups 
"deal.II User Group" group.
To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.


Re: AW: [deal.II] step-42 clarification

2018-01-19 Thread Alberto Salvadori
Hi Wolfgang and Jörg

I am taking advantage for a second question. I have made a few minor
changes in the code and re-implemented it. In serial version, all works
fine so far. However, when running in parallel, I am seeing an issue in the
method PlasticityContactProblem::update_solution_and_constraints.

In particular, it turns out that the value of

const unsigned int index_z = dof_indices[q_point];

might be out of the range of

TrilinosWrappers::MPI::Vector

lambda(locally_relevant_dofs, mpi_communicator);
lambda = newton_rhs_uncondensed;

I have solved run-time issues by checking if

if ( lambda.in_local_range(index_z))

but I wonder if the issue is possible (in principle, I mean) for the
published code or is it my implementation that is not correct? Note that I
am basically implementing step-42 upon the code built in step-20 using
PETScWrappers::MPI::Vector, rather than step-40. If of use, I am writing my
method below.

Thanks for your help.

Alberto


::update_solution_and_constraints ()


// The following function is the first function we call in each outer loop
of the Newton iteration.

// What it does is to project the solution onto the feasible set and update
the active set for the degrees of freedom that touch or penetrate the
obstacle.


{



  std::pair  vrange;



  this->IO.log() << " In update_solution_and_constraints. " << std::flush;



  // We need to write into the solution vector (which we can only do with
fully distributed vectors without ghost elements) and we need to read the
Lagrange multiplier and the elements of the diagonal mass matrix from their
respective vectors (which we can only do with vectors that do have ghost
elements), so we create the respective vectors. We then also initialize the
constraints object that will contain constraints from contact, as well as
an object that contains an index set of all locally owned degrees of
freedom that are part of the contact:



  std::vector dof_touched( this->dof_handler.n_dofs(), false);



  PETScWrappers::MPI::Vector distributed_solution( this->locally_owned_dofs,
this->mpi_communicator );

  distributed_solution = this->accumulated_displacement;

  vrange = distributed_solution.local_range();

  this->IO.log() << " distributed_solution local range =  " << vrange.first
<< ", " << vrange.second << "\n"  << std::flush;




  PETScWrappers::MPI::Vector lambda( this->locally_relevant_dofs, this
->mpi_communicator);

  lambda = this->system_rhs_uncondensed;

  vrange = lambda.local_range();

  this->IO.log() << " lambda local range =  " << vrange.first << ", " <<
vrange.second << "\n"  << std::flush;




  PETScWrappers::MPI::Vector diag_mass_matrix_vector_relevant(
this->locally_relevant_dofs,
this->mpi_communicator);

  diag_mass_matrix_vector_relevant = this->diag_mass_matrix_vector;

  vrange = diag_mass_matrix_vector_relevant.local_range();

  this->IO.log() << " diag_mass_matrix_vector_relevant local range =  " <<
vrange.first << ", " << vrange.second << "\n"  << std::flush;




  this->all_constraints.reinit( this->locally_relevant_dofs );

  this->contact_constraints.reinit( this->locally_relevant_dofs );

  this->active_set.clear();



  // The second part is a loop over all cells in which we look at each
point where a degree of freedom is defined whether the active set condition
is true and we need to add this degree of freedom to the active set of
contact nodes. As we always do, if we want to evaluate functions at
individual points, we do this with an FEValues object (or, here, an
FEFaceValues object since we need to check contact at the surface) with an
appropriately chosen quadrature object. We create this face quadrature
object by choosing the "support points" of the shape functions defined on
the faces of cells (for more on support points, see this glossary entry).
As a consequence, we have as many quadrature points as there are shape
functions per face and looping over quadrature points is equivalent to
looping over shape functions defined on a face. With this, the code looks
as follows:



  Quadrature face_quadrature( this
->fe.get_unit_face_support_points());

  FEFaceValues fe_values_face( this->fe, face_quadrature,
update_quadrature_points );

  const unsigned int dofs_per_face = this->fe.dofs_per_face;

  const unsigned int n_face_q_points = face_quadrature.size();

  std::vector dof_indices(dofs_per_face);



  typename DoFHandler::active_cell_iterator

  cell = this->dof_handler.begin_active(),

  endc = this->dof_handler.end();

  for (; cell != endc; ++cell)

if (!cell->is_artificial())

{

  if (cell->is_locally_owned())  // MY OWN CODE

  {

for (unsigned int face=0; faceface(face)->at_boundary()

  &&

  

AW: AW: [deal.II] step-42 clarification

2018-01-17 Thread Frohne, Joerg
>>On 01/17/2018 02:45 PM, Frohne, Joerg wrote:
>> obviously this is a mistake. I checked the source files which we have used 
>> for results in corresponding paper.
>> There I have found the following coding:
>>
>>resid_old = resid;
>>
>>resid_vector = system_rhs_newton;
>>resid_vector.compress(VectorOperation::insert);
>>
>>int is_my_set_changed = (active_set == active_set_old) ? 0 : 1;
>>int num_changed = Utilities::MPI::sum(is_my_set_changed,
>>MPI_COMM_WORLD);
>>if (num_changed == 0 && resid < 1e-8)
>>  break;
>>active_set_old = active_set;
>>
>> Unfortunately I have not been working with deal.ii for over two years now.
>> For this reason I would be glad if someone else could fix this bug.
>> Otherwise I would need a short manual how to do it by myself.

>I can do that for you. Do I understand correctly that the only change
>that needs to happen is to move
>   active_set_old = active_set;
>to *after* the if-statement?

Exactly.

Best,
Joerg

-- 
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 received this message because you are subscribed to the Google Groups 
"deal.II User Group" group.
To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.


Re: AW: [deal.II] step-42 clarification

2018-01-17 Thread Wolfgang Bangerth

On 01/17/2018 02:45 PM, Frohne, Joerg wrote:

obviously this is a mistake. I checked the source files which we have used for 
results in corresponding paper.
There I have found the following coding:

   resid_old = resid;

   resid_vector = system_rhs_newton;
   resid_vector.compress(VectorOperation::insert);

   int is_my_set_changed = (active_set == active_set_old) ? 0 : 1;
   int num_changed = Utilities::MPI::sum(is_my_set_changed,
   MPI_COMM_WORLD);
   if (num_changed == 0 && resid < 1e-8)
 break;
   active_set_old = active_set;

Unfortunately I have not been working with deal.ii for over two years now.
For this reason I would be glad if someone else could fix this bug.
Otherwise I would need a short manual how to do it by myself.


I can do that for you. Do I understand correctly that the only change 
that needs to happen is to move

  active_set_old = active_set;
to *after* the if-statement?

Hope you're doing alright! 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/dealii?hl=en
--- 
You received this message because you are subscribed to the Google Groups "deal.II User Group" group.

To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.


AW: [deal.II] step-42 clarification

2018-01-17 Thread Frohne, Joerg
Dear Wolfgang, dear community,

obviously this is a mistake. I checked the source files which we have used for 
results in corresponding paper.
There I have found the following coding:

  resid_old = resid;

  resid_vector = system_rhs_newton;
  resid_vector.compress(VectorOperation::insert);

  int is_my_set_changed = (active_set == active_set_old) ? 0 : 1;
  int num_changed = Utilities::MPI::sum(is_my_set_changed,
  MPI_COMM_WORLD);
  if (num_changed == 0 && resid < 1e-8)
break;
  active_set_old = active_set;

Unfortunately I have not been working with deal.ii for over two years now.
For this reason I would be glad if someone else could fix this bug.
Otherwise I would need a short manual how to do it by myself.

With the best wishes for the future for deal.ii and their developers!
Joerg



Von: Wolfgang Bangerth [bange...@colostate.edu]
Gesendet: Dienstag, 16. Januar 2018 21:48
An: dealii@googlegroups.com; Frohne, Joerg
Cc: Suttmeier, Franz-Theo
Betreff: Re: [deal.II] step-42 clarification

On 01/16/2018 12:59 AM, Alberto Salvadori wrote:
> Dear community,
>
> I am studying with pleasure step-42 and I got a bit confused in the
> method PlasticityContactProblem::solve_newton. At the very end of it, we
> find these instructions:
>
> old_active_set = active_set;
> previous_residual_norm = residual_norm;
> if (Utilities::MPI::sum
> <http://www.dealii.org/8.5.0/doxygen/deal.II/namespaceUtilities_1_1MPI.html#ab544a3bf3301a6dd3e705ee352c5551b>((active_set
> == old_active_set) ? 0 : 1,
> mpi_communicator) == 0)
> {
> pcout << " Active set did not change!" << std::endl;
> if (residual_norm < 1e-10)
> break;
> }
>
>
> Now, I am a bit confused by the if statement and I am clearly missing
> something. The first instruction makes old_active_set equal to
> active_set. Accordingly, wouldn't active_set == old_active_set  always
> be true? What am I missing?

You're right -- the code would suggest that the if-condition is always
true and that what matter is only the inner if.

I'm not sure I have the current email address of Joerg Frohne who wrote
step-42. He would be the one who could possibly provide a better answer.

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/forum/dealii?hl=en
--- 
You received this message because you are subscribed to the Google Groups 
"deal.II User Group" group.
To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.


Re: [deal.II] step-42 clarification

2018-01-16 Thread Wolfgang Bangerth

On 01/16/2018 12:59 AM, Alberto Salvadori wrote:

Dear community,

I am studying with pleasure step-42 and I got a bit confused in the 
method PlasticityContactProblem::solve_newton. At the very end of it, we 
find these instructions:


old_active_set = active_set;
previous_residual_norm = residual_norm;
if (Utilities::MPI::sum 
((active_set 
== old_active_set) ? 0 : 1,

mpi_communicator) == 0)
{
pcout << " Active set did not change!" << std::endl;
if (residual_norm < 1e-10)
break;
}


Now, I am a bit confused by the if statement and I am clearly missing 
something. The first instruction makes old_active_set equal to 
active_set. Accordingly, wouldn't active_set == old_active_set  always 
be true? What am I missing?


You're right -- the code would suggest that the if-condition is always 
true and that what matter is only the inner if.


I'm not sure I have the current email address of Joerg Frohne who wrote 
step-42. He would be the one who could possibly provide a better answer.


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/forum/dealii?hl=en
--- 
You received this message because you are subscribed to the Google Groups "deal.II User Group" group.

To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.


[deal.II] step-42 clarification

2018-01-16 Thread Alberto Salvadori
Dear community,

I am studying with pleasure step-42 and I got a bit confused in the method 
PlasticityContactProblem::solve_newton. At the very end of it, we find 
these instructions:

old_active_set = active_set;
previous_residual_norm = residual_norm;
 
if (Utilities::MPI::sum 
((active_set
 
== old_active_set) ? 0 : 1,
mpi_communicator) == 0)
{
pcout << " Active set did not change!" << std::endl;
if (residual_norm < 1e-10)
break;
}


Now, I am a bit confused by the if statement and I am clearly missing 
something. The first instruction makes old_active_set equal to active_set. 
Accordingly, wouldn't active_set == old_active_set  always be true? What am 
I missing?

Thanks for your help

Alberto

-- 

Informativa sulla Privacy: http://www.unibs.it/node/8155

-- 
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 received this message because you are subscribed to the Google Groups 
"deal.II User Group" group.
To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.


[deal.II] Step-42

2017-05-14 Thread benhour . amirian66
Dear All,
I really appreciate it if you let me know how I can run step 42 because 
whenever I ran it, I got two error without any information about that. This 
is exactly the same with "goal oriented mesh adaptivity in elastoplasticity 
proiblems" example which is written by Shahram. Looking forward to hearing 
from you.

Thanks,
Ben

-- 
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 received this message because you are subscribed to the Google Groups 
"deal.II User Group" group.
To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.


Re: [deal.II] Step-42 -- Problem with Trilinos and P4EST

2016-08-03 Thread Daniel Arndt
Ehsan,

Good that you found the error. Another possibility is to use ccmake.
This works for me quite well.

Best,
Daniel


Am Mittwoch, 3. August 2016 11:37:14 UTC+2 schrieb Ehsan:
>
> Finally I found the problem after installing and uninstalling for more 
> than ten times.
> The problem was the space after "=" !!
> There should be NO space before and after "=" in setting cmake variable.
>
>
> On Monday, August 1, 2016 at 3:49:56 PM UTC+2, Jean-Paul Pelteret wrote:
>>
>> Dear Eshan,
>>
>> Sometimes it is necessary to manually remove CMakeCache.txt before 
>> reconfiguring a project. Can you try to do this and see if you have any 
>> further success?
>>
>> Regards,
>> J-P
>>
>> On Monday, August 1, 2016 at 2:42:25 PM UTC+2, Ehsan wrote:
>>>
>>> Dear Daniel,
>>> I checked the "detailed.log" file and noticed that DEAL_II_WITH_MPI, 
>>> DEAL_II_WITH_P4EST and DEAL_II_WITH_TRILINOS all three are off.
>>> my cmake is:
>>> cmake 
>>> -DCMAKE_INSTALL_PREFIX=/home/General_for_All_Users/deal_II_install_dir 
>>> -DDEAL_II_WITH_64BIT_INDICES= ON 
>>> -DDEAL_II_WITH_MPI= ON 
>>> -DDEAL_II_WITH_P4EST= ON 
>>> -DDEAL_II_WITH_TRILINOS= ON 
>>> -DP4EST_DIR=/home/General_for_All_Users/P4EST_install_dir/ 
>>> -DTRILINOS_DIR=/home/General_for_All_Users/Trilinos_install_dir/trilinos_path/
>>>  
>>>
>>> ..
>>>
>>> I also attached the detailed.log file.
>>> When I put -DCMAKE_INSTALL_PREFIX before options related to MPI, P4EST 
>>> and TRILINOS, it is implemented.
>>> So something is wrong with setting MPI, P4EST or TRILINOS but I do not 
>>> know what !!!
>>>
>>> best regards.
>>> Ehsan
>>>
>>>
>>> On Monday, August 1, 2016 at 2:32:22 PM UTC+2, Ehsan wrote:

 Dear Daniel,

 When I run cmake in terminal and the end I receive below warning:

 CMake Warning:
   Manually-specified variables were not used by the project:

 P4EST_DIR
 TRILINOS_DIR

 How should I solve this problem.
 Best regards.
 Ehsan

 On Monday, August 1, 2016 at 2:21:31 PM UTC+2, Ehsan wrote:
>
> Dear Daniel,
>
> In the "detailed.log" the "CMAKE_INSTALL_PREFIX:" is empty but I am 
> sure that I defined it in cmake:
> I have a generat question.
> is it possible to compile deal ii with enabled Trilinos, P4EST, and 
> MPI options?
>
> Best regards.
> Ehsan
>
>
>
> On Wednesday, July 27, 2016 at 8:52:36 PM UTC+2, Daniel Arndt wrote:
>>
>> Ehsan,
>>
>> can you show us what your "detailed.log" in the build directory looks 
>> like?
>> This file stores the configuration that is used for building deal.II.
>> ` -DCMAKE_INSTALL_PREFIX= /home/General_for_All_Users/
>> deal_II_install_dir` should tell deal.II to copy the build library 
>> into that folder
>> when you are invoking `$make install`.
>>
>> Best,
>> Daniel
>>
>

-- 
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 received this message because you are subscribed to the Google Groups 
"deal.II User Group" group.
To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.


Re: [deal.II] Step-42 -- Problem with Trilinos and P4EST

2016-08-01 Thread Jean-Paul Pelteret
Dear Eshan,

Sometimes it is necessary to manually remove CMakeCache.txt before 
reconfiguring a project. Can you try to do this and see if you have any 
further success?

Regards,
J-P

On Monday, August 1, 2016 at 2:42:25 PM UTC+2, Ehsan wrote:
>
> Dear Daniel,
> I checked the "detailed.log" file and noticed that DEAL_II_WITH_MPI, 
> DEAL_II_WITH_P4EST and DEAL_II_WITH_TRILINOS all three are off.
> my cmake is:
> cmake 
> -DCMAKE_INSTALL_PREFIX=/home/General_for_All_Users/deal_II_install_dir 
> -DDEAL_II_WITH_64BIT_INDICES= ON 
> -DDEAL_II_WITH_MPI= ON 
> -DDEAL_II_WITH_P4EST= ON 
> -DDEAL_II_WITH_TRILINOS= ON 
> -DP4EST_DIR=/home/General_for_All_Users/P4EST_install_dir/ 
> -DTRILINOS_DIR=/home/General_for_All_Users/Trilinos_install_dir/trilinos_path/
>  
>
> ..
>
> I also attached the detailed.log file.
> When I put -DCMAKE_INSTALL_PREFIX before options related to MPI, P4EST 
> and TRILINOS, it is implemented.
> So something is wrong with setting MPI, P4EST or TRILINOS but I do not 
> know what !!!
>
> best regards.
> Ehsan
>
>
> On Monday, August 1, 2016 at 2:32:22 PM UTC+2, Ehsan wrote:
>>
>> Dear Daniel,
>>
>> When I run cmake in terminal and the end I receive below warning:
>>
>> CMake Warning:
>>   Manually-specified variables were not used by the project:
>>
>> P4EST_DIR
>> TRILINOS_DIR
>>
>> How should I solve this problem.
>> Best regards.
>> Ehsan
>>
>> On Monday, August 1, 2016 at 2:21:31 PM UTC+2, Ehsan wrote:
>>>
>>> Dear Daniel,
>>>
>>> In the "detailed.log" the "CMAKE_INSTALL_PREFIX:" is empty but I am sure 
>>> that I defined it in cmake:
>>> I have a generat question.
>>> is it possible to compile deal ii with enabled Trilinos, P4EST, and MPI 
>>> options?
>>>
>>> Best regards.
>>> Ehsan
>>>
>>>
>>>
>>> On Wednesday, July 27, 2016 at 8:52:36 PM UTC+2, Daniel Arndt wrote:

 Ehsan,

 can you show us what your "detailed.log" in the build directory looks 
 like?
 This file stores the configuration that is used for building deal.II.
 ` -DCMAKE_INSTALL_PREFIX= /home/General_for_All_Users/
 deal_II_install_dir` should tell deal.II to copy the build library 
 into that folder
 when you are invoking `$make install`.

 Best,
 Daniel

>>>

-- 
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 received this message because you are subscribed to the Google Groups 
"deal.II User Group" group.
To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.


Re: [deal.II] Step-42 -- Problem with Trilinos and P4EST

2016-08-01 Thread Ehsan
Dear Daniel,
I checked the "detailed.log" file and noticed that DEAL_II_WITH_MPI, 
DEAL_II_WITH_P4EST and DEAL_II_WITH_TRILINOS all three are off.
my cmake is:
cmake 
-DCMAKE_INSTALL_PREFIX=/home/General_for_All_Users/deal_II_install_dir 
-DDEAL_II_WITH_64BIT_INDICES= ON 
-DDEAL_II_WITH_MPI= ON 
-DDEAL_II_WITH_P4EST= ON 
-DDEAL_II_WITH_TRILINOS= ON 
-DP4EST_DIR=/home/General_for_All_Users/P4EST_install_dir/ 
-DTRILINOS_DIR=/home/General_for_All_Users/Trilinos_install_dir/trilinos_path/ 

..

I also attached the detailed.log file.
When I put -DCMAKE_INSTALL_PREFIX before options related to MPI, P4EST and 
TRILINOS, it is implemented.
So something is wrong with setting MPI, P4EST or TRILINOS but I do not know 
what !!!

best regards.
Ehsan


On Monday, August 1, 2016 at 2:32:22 PM UTC+2, Ehsan wrote:
>
> Dear Daniel,
>
> When I run cmake in terminal and the end I receive below warning:
>
> CMake Warning:
>   Manually-specified variables were not used by the project:
>
> P4EST_DIR
> TRILINOS_DIR
>
> How should I solve this problem.
> Best regards.
> Ehsan
>
> On Monday, August 1, 2016 at 2:21:31 PM UTC+2, Ehsan wrote:
>>
>> Dear Daniel,
>>
>> In the "detailed.log" the "CMAKE_INSTALL_PREFIX:" is empty but I am sure 
>> that I defined it in cmake:
>> I have a generat question.
>> is it possible to compile deal ii with enabled Trilinos, P4EST, and MPI 
>> options?
>>
>> Best regards.
>> Ehsan
>>
>>
>>
>> On Wednesday, July 27, 2016 at 8:52:36 PM UTC+2, Daniel Arndt wrote:
>>>
>>> Ehsan,
>>>
>>> can you show us what your "detailed.log" in the build directory looks 
>>> like?
>>> This file stores the configuration that is used for building deal.II.
>>> ` -DCMAKE_INSTALL_PREFIX= /home/General_for_All_Users/
>>> deal_II_install_dir` should tell deal.II to copy the build library into 
>>> that folder
>>> when you are invoking `$make install`.
>>>
>>> Best,
>>> Daniel
>>>
>>

-- 
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 received this message because you are subscribed to the Google Groups 
"deal.II User Group" group.
To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.
###
#
#  deal.II configuration:
#CMAKE_BUILD_TYPE:   DebugRelease
#BUILD_SHARED_LIBS:  ON
#CMAKE_INSTALL_PREFIX:   /home/General_for_All_Users/deal_II_install_dir
#CMAKE_SOURCE_DIR:   
/home/General_for_All_Users/deal_II/dealii-8.4.1
#(version 8.4.1)
#CMAKE_BINARY_DIR:   
/home/General_for_All_Users/deal_II/dealii-8.4.1/build
#CMAKE_CXX_COMPILER: GNU 4.8.4 on platform Linux x86_64
#/usr/bin/c++
#CMAKE_C_COMPILER:   /usr/bin/cc
#CMAKE_Fortran_COMPILER: /usr/bin/gfortran
#CMAKE_GENERATOR:Unix Makefiles
#
#  Base configuration (prior to feature configuration):
#DEAL_II_CXX_FLAGS:-pedantic -fpic -Wall -Wextra 
-Wpointer-arith -Wwrite-strings -Wsynth -Wsign-compare -Wswitch 
-Woverloaded-virtual -Wno-long-long -Wno-deprecated-declarations 
-Wno-literal-suffix -std=c++11
#DEAL_II_CXX_FLAGS_RELEASE:-O2 -funroll-loops -funroll-all-loops 
-fstrict-aliasing
#DEAL_II_CXX_FLAGS_DEBUG:  -Og -ggdb -Wa,--compress-debug-sections
#DEAL_II_LINKER_FLAGS: -Wl,--as-needed -rdynamic -fuse-ld=gold
#DEAL_II_LINKER_FLAGS_RELEASE: 
#DEAL_II_LINKER_FLAGS_DEBUG:   -ggdb
#DEAL_II_DEFINITIONS:  
#DEAL_II_DEFINITIONS_RELEASE:  
#DEAL_II_DEFINITIONS_DEBUG:DEBUG
#DEAL_II_USER_DEFINITIONS: 
#DEAL_II_USER_DEFINITIONS_REL: 
#DEAL_II_USER_DEFINITIONS_DEB: DEBUG
#DEAL_II_INCLUDE_DIRS  
#DEAL_II_USER_INCLUDE_DIRS:
#DEAL_II_BUNDLED_INCLUDE_DIRS: 
#DEAL_II_LIBRARIES:m
#DEAL_II_LIBRARIES_RELEASE:
#DEAL_II_LIBRARIES_DEBUG:  
#
#  Configured Features (DEAL_II_ALLOW_BUNDLED = ON, DEAL_II_ALLOW_AUTODETECTION 
= ON):
#  ( DEAL_II_WITH_64BIT_INDICES =  )
#  ( DEAL_II_WITH_ARPACK = OFF )
#DEAL_II_WITH_BOOST set up with bundled packages
#BOOST_CXX_FLAGS = -Wno-unused-local-typedefs
#BOOST_BUNDLED_INCLUDE_DIRS = 
/home/General_for_All_Users/deal_II/dealii-8.4.1/bundled/boost-1.56.0/include
#BOOST_LIBRARIES = rt
#  ( DEAL_II_WITH_BZIP2 = OFF )
#DEAL_II_WITH_CXX11 = ON
#  ( DEAL_II_WITH_CXX14 = OFF )
#  ( DEAL_II_WITH_HDF5 = OFF )
#DEAL_II_WITH_LAPACK set up with external dependencies
#LAPACK_LINKER_FLAGS = 
#LAPACK_LIBRARIES = 
/usr/lib/liblapack.so;/usr/lib/libf77blas.so;/usr/lib/libatlas.so;gfortran;quadmath;m;c
#  ( DEAL_II_WITH_METIS = OFF )
#  ( DEAL_II_WITH_MPI = OFF 

Re: [deal.II] Step-42 -- Problem with Trilinos and P4EST

2016-08-01 Thread Ehsan
Dear Daniel,

When I run cmake in terminal and the end I receive below warning:

CMake Warning:
  Manually-specified variables were not used by the project:

P4EST_DIR
TRILINOS_DIR

How should I solve this problem.
Best regards.
Ehsan

On Monday, August 1, 2016 at 2:21:31 PM UTC+2, Ehsan wrote:
>
> Dear Daniel,
>
> In the "detailed.log" the "CMAKE_INSTALL_PREFIX:" is empty but I am sure 
> that I defined it in cmake:
> I have a generat question.
> is it possible to compile deal ii with enabled Trilinos, P4EST, and MPI 
> options?
>
> Best regards.
> Ehsan
>
>
>
> On Wednesday, July 27, 2016 at 8:52:36 PM UTC+2, Daniel Arndt wrote:
>>
>> Ehsan,
>>
>> can you show us what your "detailed.log" in the build directory looks 
>> like?
>> This file stores the configuration that is used for building deal.II.
>> ` -DCMAKE_INSTALL_PREFIX= /home/General_for_All_Users/
>> deal_II_install_dir` should tell deal.II to copy the build library into 
>> that folder
>> when you are invoking `$make install`.
>>
>> Best,
>> Daniel
>>
>

-- 
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 received this message because you are subscribed to the Google Groups 
"deal.II User Group" group.
To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.


Re: [deal.II] Step-42 -- Problem with Trilinos and P4EST

2016-07-27 Thread Ehsan
Dear Toby,
Thanks for your reply.

I deleted folder of my previous deal ii installation and installed it again 
and now I faced two other problems.
Can you please help me solve them:

First: previously when I installed deal-ii without MPI, Trilinos and P4EST 
options and addresse deall-ii to be installed ins a specific directory with  
-DCMAKE_INSTALL_PREFIX= /home/General_for_All_Users/deal_II_install_dir  
option, 
it was installed in the same directory.
But, this time, it seems that this option is not implemented and it is 
installed in somewhere else. 
How can I know where is the deal-ii installation directory?
How can I uninstall deal-ii and all related packages completely to install 
it again (have a fresh installation)?

Second: Why deall-ii created a folder in root (/share/deal.II/) which has 
two sub folders (macros and scripts) ?
Previous version of deal-ii did not create this folder?
How can I change the path of this folder?

Thanks
Ehsan

On Wednesday, July 27, 2016 at 12:42:03 PM UTC+2, Tobi Young wrote:
>
> Ehsan. 
>
> Yes, but that is not what you have done.   ;-) 
>
> Look at the configure script in your first email again calmly and 
> *very carefully* and then look at my reply calmly and *very 
> carefully*. 
>
> In the configure script you sent us, you are missing a D on two lines, 
> which I am guessing is stopping cmake from finding p4est and trilinos 
> and is the reason you can not compile some of the tutorials. Have you 
> checked the output from cmake or configure.log? 
>
> Trust me, it works, but only if your syntax configuring deal.II is 
> correct.   :-) 
>
> Best, 
>Toby 
>
>
>
> 2016-07-27 12:29 GMT+02:00 Ehsan : 
> > Dear Toby, 
> > 
> > But in below links they are -DDEAL_II_With_... 
> > 
> > https://www.dealii.org/developer/readme.html 
> > https://www.dealii.org/developer/external-libs/p4est.html 
> > 
> > Best, 
> > Ehsan 
> > 
> > 
> > 
> > On Wednesday, July 27, 2016 at 12:19:07 PM UTC+2, Tobi Young wrote: 
> >> 
> >> Hello Eshan, 
> >> 
> >> Perhaps here is your error. It is a simple typo. ;-) 
> >> 
> >> >   -DEAL_II_WITH_P4EST= ON 
> >> >   -DEAL_II_WITH_TRILINOS= ON 
> >> 
> >> Should be: 
> >> 
> >>-DDEAL_II_WITH_P4EST= ON 
> >>-DDEAL_II_WITH_TRILINOS= ON 
> >> 
> >> Please check that the output (or configure.log) says it has found all 
> >> of the libraries you were looking for and then recompile. 
> >> Destroy CMakeCache before reconfiguring. 
> >> 
> >> I hope that helps you out. 
> >> 
> >> Best, 
> >>Toby 
> > 
> > -- 
> > 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 received this message because you are subscribed to the Google 
> Groups 
> > "deal.II User Group" group. 
> > To unsubscribe from this group and stop receiving emails from it, send 
> an 
> > email to dealii+un...@googlegroups.com . 
> > For more options, visit https://groups.google.com/d/optout. 
>

-- 
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 received this message because you are subscribed to the Google Groups 
"deal.II User Group" group.
To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.


Re: [deal.II] Step-42 -- Problem with Trilinos and P4EST

2016-07-27 Thread Tobi Young
Ehsan.

Yes, but that is not what you have done.   ;-)

Look at the configure script in your first email again calmly and
*very carefully* and then look at my reply calmly and *very
carefully*.

In the configure script you sent us, you are missing a D on two lines,
which I am guessing is stopping cmake from finding p4est and trilinos
and is the reason you can not compile some of the tutorials. Have you
checked the output from cmake or configure.log?

Trust me, it works, but only if your syntax configuring deal.II is
correct.   :-)

Best,
   Toby



2016-07-27 12:29 GMT+02:00 Ehsan :
> Dear Toby,
>
> But in below links they are -DDEAL_II_With_...
>
> https://www.dealii.org/developer/readme.html
> https://www.dealii.org/developer/external-libs/p4est.html
>
> Best,
> Ehsan
>
>
>
> On Wednesday, July 27, 2016 at 12:19:07 PM UTC+2, Tobi Young wrote:
>>
>> Hello Eshan,
>>
>> Perhaps here is your error. It is a simple typo. ;-)
>>
>> >   -DEAL_II_WITH_P4EST= ON
>> >   -DEAL_II_WITH_TRILINOS= ON
>>
>> Should be:
>>
>>-DDEAL_II_WITH_P4EST= ON
>>-DDEAL_II_WITH_TRILINOS= ON
>>
>> Please check that the output (or configure.log) says it has found all
>> of the libraries you were looking for and then recompile.
>> Destroy CMakeCache before reconfiguring.
>>
>> I hope that helps you out.
>>
>> Best,
>>Toby
>
> --
> 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 received this message because you are subscribed to the Google Groups
> "deal.II User Group" group.
> To unsubscribe from this group and stop receiving emails from it, send an
> email to dealii+unsubscr...@googlegroups.com.
> For more options, visit https://groups.google.com/d/optout.

-- 
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 received this message because you are subscribed to the Google Groups 
"deal.II User Group" group.
To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.


Re: [deal.II] Step-42 -- Problem with Trilinos and P4EST

2016-07-27 Thread Ehsan
Hi,
Moreover I have 2 more problems.

First: previously when I installed deal-ii without MPI, Trilinos and P4EST 
options and addresse deall-ii to be installed ins a specific directory with  
-DCMAKE_INSTALL_PREFIX= /home/General_for_All_Users/deal_II_install_dir  
option, 
it was installed in the same directory.
But, this time, it seems that this option is not implemented and it is 
installed in somewhere else. 
How can I know where is the deal-ii installation directory?
How can I uninstall deal-ii and all related packages completely to install 
it again (have a fresh installation)?

Second: Why deall-ii created a folder in root (/share/deal.II/) which has 
two sub folders (macros and scripts) ?
Previous version of deal-ii did not create this folder?
How can I change the path of this folder?

Thanks
Ehsan

On Wednesday, July 27, 2016 at 12:29:34 PM UTC+2, Ehsan wrote:
>
> Dear Toby,
>
> But in below links they are -DDEAL_II_With_...
>
> https://www.dealii.org/developer/readme.html 
> https://www.dealii.org/developer/external-libs/p4est.html
>
> Best,
> Ehsan
>
>
> On Wednesday, July 27, 2016 at 12:19:07 PM UTC+2, Tobi Young wrote:
>>
>> Hello Eshan, 
>>
>> Perhaps here is your error. It is a simple typo. ;-) 
>>
>> >   -DEAL_II_WITH_P4EST= ON 
>> >   -DEAL_II_WITH_TRILINOS= ON 
>>
>> Should be: 
>>
>>-DDEAL_II_WITH_P4EST= ON 
>>-DDEAL_II_WITH_TRILINOS= ON 
>>
>> Please check that the output (or configure.log) says it has found all 
>> of the libraries you were looking for and then recompile. 
>> Destroy CMakeCache before reconfiguring. 
>>
>> I hope that helps you out. 
>>
>> Best, 
>>Toby 
>>
>

-- 
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 received this message because you are subscribed to the Google Groups 
"deal.II User Group" group.
To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
For more options, visit https://groups.google.com/d/optout.