Re: [deal.II] Re: mapping_collection and step-27

2017-12-01 Thread Juan Carlos Araujo Cabarcas
Thanks again! that one was very logical ... silly me!

To review, now it looks like this:

  std::map bval;
  
  ZeroFunction   homogeneous_dirichlet_bc;
  
  const typename FunctionMap::type 
dirichlet_boundary_functions
  = { { types::boundary_id(0), _dirichlet_bc } };   
   
  
  VectorTools::interpolate_boundary_values (mapping_collection,

  dof_handler,

dirichlet_boundary_functions,
bval);

and gives the following error (no candidates this time):

path/petsc_eigs/pFEM.cc:370: error: undefined reference to 'void 
dealii::VectorTools::interpolate_boundary_values<2, 2, std::complex 
>(dealii::hp::MappingCollection<2, 2> const&, dealii::hp::DoFHandler<2, 2> 
const&, std::map > 
const*, std::less, std::allocator const*> > > const&, 
std::map, std::less, 
std::allocator > >&, 
dealii::ComponentMask const&)'
collect2: error: ld returned 1 exit status
make[2]: *** [pFEM] Error 1
make[1]: *** [CMakeFiles/pFEM.dir/all] Error 2
make: *** [all] Error 2

Any comments? thanks in advance,
Juan Araújo


El viernes, 1 de diciembre de 2017, 15:49:48 (UTC-5), Wolfgang Bangerth 
escribió:
>
> On 12/01/2017 01:29 PM, Juan Carlos Araujo Cabarcas wrote: 
> > 
> > I must admit that I am a bit lost here. However, I tried your suggestion 
> > and used:FunctionMap::type,  what gave the errors 
> > that I attach in errors.txt. 
> > 
> > By looking at those errors, I also tried: 
> >  std::map > std::complex > >  bval; 
> > but it seems that this is not the root of the problem (I also attach 
> > these errors at the end of the same file). 
> > 
> > Any ideas? Thanks in advance. 
>
> Yes. You are now trying assign a `ZeroFunction` object's address to 
> a FunctionMap::type, but this wants the address of a 
> complex-valued function. You need to use 
>ZeroFunction 
> now to explain to the compiler that you want a function that returns a 
> std::complex (==PetscScalar)-typed zero, rather than a real-valued one. 
>
> 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.
For more options, visit https://groups.google.com/d/optout.


[deal.II] compile master without examples using Candi

2017-12-01 Thread RAJAT ARORA
Hello,

>From one of the posts, I came to know that 
DEAL_II_COMPILE_EXAMPLES=ON by default for master.

I am installing deal.ii master branch using candi.

I do the build myself, I can pass that flag = OFF during the "cmake ." step 
but can anyone please tell me, how can I switch it off if I am using 
candi to install deal.ii ?

Thanks.

-- 
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] Re: Error during p4est installation

2017-12-01 Thread feapman
Hi Bruno & DEAL.ii Team,

many thanks for your suggestion & help!

now I install p4est in a new order which contains three directories: source 
directory, build directory, and install directory

Warm regards,
Yaakov
 

On Friday, December 1, 2017 at 3:03:29 PM UTC+1, Bruno Turcksin wrote:
>
> Yaakov,
>
> 2017-12-01 8:26 GMT-05:00 :
>
>> one is defined order p4est
>> new one is p4est-build
>>
> p4est: directory where you wanted to install p4est 
> p4est-build: directory where p4est is compiled. This can be removed once 
> p4est is installed.
> It is common when you install a library to have three directories: source 
> directory, build directory, and install directory
>
> Best,
>
> Bruno
>

-- 
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-22 partial boundary conditions

2017-12-01 Thread Wolfgang Bangerth


Jane,

The whole point of not imposing zero for all components in a Dirichlet 
sense is that I am testing for a case where I have inhomogeneous normal 
component of the normal stress, with the tangential stress being zero on 
some boundaries.


This case is easy: the stress is only imposed weakly anyway, so you need 
to put this into the bilinear form.



On some boundaries, I have zero normal flux and zero 
tangential stress but I'm pretty sure this doesn't amount to the actual 
components being zero anyway.


Correct. In this case, all you need to do is impose a nonzero normal 
flux (for which I believe there is a function); the tangential stress 
would have to be imposed in the bilinear form, but since it's zero there 
is nothing to do (the term one would have to add to the bilinear form 
just happens to be zero).


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] Re: Wrong result in use of FEEvaluation with different ConstraintMatrix objects

2017-12-01 Thread Sambit Das
Just to clarify my observations on serial and parallel discrepancy- The 
value from case 1 remains same for serial and parallel, while case 2 gives 
different values for serial and parallel.

On Friday, December 1, 2017 at 3:39:20 PM UTC-6, Sambit Das wrote:
>
> Hi All,
>
> I have reduced my bug to the following minimal example: I create a 
> MatrixFree object for two different ConstraintMatrices (provided as vector 
> of ConstraintMatrices to the reinit(..)). 
>
> matrix_free_data.reinit(dofHandlerVector, d_constraintsVector, 
> quadratureVector, additional_data);
>
> The dofHandlers are the same for both the ConstraintMatrices. Only 
> difference- the first ConstraintMatrix has periodic constraints while the 
> second one has no constraints. Next I run two cases
>
> *  Case1: *
>
>   FEEvaluation<3,FEOrder,FEOrder+1,1> phiTotEval(matrix_free_data,0, 0);
>   const unsigned int 
> numSubCells=matrix_free_data.n_components_filled(cell);
>   const int numQuadPoints=phiTotEval.n_q_points;
>
>   double phiTotRhoOutQuadSum=0.0;
>   for (unsigned int cell=0; cell
> phiTotEval.reinit(cell); 
> phiTotEval.read_dof_values_plain(dftPtr->poissonPtr->phiTotRhoOut); 
> //phiTotRhoOut is a  parallel::distributed::Vector where I have previously 
> called ConstraintMatrix(the one with periodic constraints)::distribute() 
> and update_ghost_values()
>   
>   // I have also called 
> matrix_free_data.initialize_dof_vector(phiTotRhoOut) prior
> phiTotEval.evaluate(true,true);
>
> for (unsigned int q=0; qVectorizedArray phiTot_q= phiTotEval.get_value(q);   
>
>for (unsigned int iSubCell=0; iSubCell   phiTotRhoOutQuadSum+=phiTot_q[iSubCell];
>}
> }
>   }
>   
>  double phiTotRhoOutQuadSumTotal=Utilities::MPI::sum(phiTotRhoOutQuadSum, 
> mpi_communicator);
>
>   if (this_mpi_process == 0){
>std::cout << "phiTotRhoOutQuadSumTotal_vectorized " << 
> phiTotRhoOutQuadSumTotal<   }
>
>
> *  Case2: *
>   Same as Case 1- only first line is changed to (The only difference in 
> both cases is the fe_id argument to FEEvaluation constructor)
>   FEEvaluation<3,FEOrder,FEOrder+1,1> phiTotEval(matrix_free_data,1, 0);
>
>
>
> I get different values of phiTotRhoOutQuadSumTotal for the two cases when 
> run on multiple processors but same value when run on single processor. 
> Comparing with a non-vectorized loop, case 1 which uses the periodic 
> constraints gives the correct answer. However going by the manual, I 
> expected the same value as I am using read_dof_values_plain(..) which 
> doesn't take any constraints into account. I am wondering if I am doing 
> anything wrong here.
>
> Best,
> Sambit
>

-- 
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] Wrong result in use of FEEvaluation with different ConstraintMatrix objects

2017-12-01 Thread Sambit Das
Hi All,

I have reduced my bug to the following minimal example: I create a 
MatrixFree object for two different ConstraintMatrices (provided as vector 
of ConstraintMatrices to the reinit(..)). 

matrix_free_data.reinit(dofHandlerVector, d_constraintsVector, 
quadratureVector, additional_data);

The dofHandlers are the same for both the ConstraintMatrices. Only 
difference- the first ConstraintMatrix has periodic constraints while the 
second one has no constraints. Next I run two cases

*  Case1: *

  FEEvaluation<3,FEOrder,FEOrder+1,1> phiTotEval(matrix_free_data,0, 0);
  const unsigned int numSubCells=matrix_free_data.n_components_filled(cell);
  const int numQuadPoints=phiTotEval.n_q_points;

  double phiTotRhoOutQuadSum=0.0;
  for (unsigned int cell=0; cellpoissonPtr->phiTotRhoOut); 
//phiTotRhoOut is a  parallel::distributed::Vector where I have previously 
called ConstraintMatrix(the one with periodic constraints)::distribute() 
and update_ghost_values()

// I have also called 
matrix_free_data.initialize_dof_vector(phiTotRhoOut) prior
phiTotEval.evaluate(true,true);

for (unsigned int q=0; q phiTotEval(matrix_free_data,1, 0);



I get different values of phiTotRhoOutQuadSumTotal for the two cases when 
run on multiple processors but same value when run on single processor. 
Comparing with a non-vectorized loop, case 1 which uses the periodic 
constraints gives the correct answer. However going by the manual, I 
expected the same value as I am using read_dof_values_plain(..) which 
doesn't take any constraints into account. I am wondering if I am doing 
anything wrong here.

Best,
Sambit

-- 
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] Re: mapping_collection and step-27

2017-12-01 Thread Wolfgang Bangerth

On 12/01/2017 01:29 PM, Juan Carlos Araujo Cabarcas wrote:


I must admit that I am a bit lost here. However, I tried your suggestion 
and used:    FunctionMap::type,  what gave the errors 
that I attach in errors.txt.


By looking at those errors, I also tried:
     std::map >  bval;
but it seems that this is not the root of the problem (I also attach 
these errors at the end of the same file).


Any ideas? Thanks in advance.


Yes. You are now trying assign a `ZeroFunction` object's address to 
a FunctionMap::type, but this wants the address of a 
complex-valued function. You need to use

  ZeroFunction
now to explain to the compiler that you want a function that returns a 
std::complex (==PetscScalar)-typed zero, rather than a real-valued one.


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] Re: mapping_collection and step-27

2017-12-01 Thread Bruno Turcksin

On Friday, December 1, 2017 at 1:47:44 PM UTC-5, Juan Carlos Araujo 
Cabarcas wrote:

> I must admit that I am a bit lost here. However, I tried your suggestion 
> and used:FunctionMap::type,  what gave the errors that 
> I attach in errors.txt.
>
> You have attached a file but it only contains an e-mail address. 

Best,

Bruno

-- 
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] Re: Spurious eigenvalues

2017-12-01 Thread Wolfgang Bangerth

On 12/01/2017 06:50 AM, Timo Heister wrote:

They're always going to be there because we keep constrained nodes in the
linear system.


If we modify the way ConstraintMatrix operates, we could work around
this though:
1. Without rescaling those equations (as we do inside ConstraintMatrix
right now) the spurious EV would all be equal to 1 and so ignoring
them is easier.


Correct. But we re-scale for a good reason, namely so that all entries 
in the matrix are of comparable size.




2. One could also zero out the constrained rows after the fact.


But only in one of the two matrices of a generalized eigenvalue problem. 
At least one of the two matrices needs to remain invertible.



3. Did we rip out the support for removing the constrained entries
from the matrix completely?


Yes.
 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] Re: mapping_collection and step-27

2017-12-01 Thread Juan Carlos Araujo Cabarcas
Thanks for your quick reply.

I used static because it was used in one of the dealii steps. As there is 
no need for it, in the following it is removed.

I must admit that I am a bit lost here. However, I tried your suggestion 
and used:FunctionMap::type,  what gave the errors that 
I attach in errors.txt.

By looking at those errors, I also tried:
std::map >  bval;
but it seems that this is not the root of the problem (I also attach these 
errors at the end of the same file).

Any ideas? Thanks in advance.

El viernes, 1 de diciembre de 2017, 8:09:26 (UTC-5), Wolfgang Bangerth 
escribió:
>
> On 11/30/2017 03:05 PM, Juan Carlos Araujo Cabarcas wrote: 
> > 
> > When using the PETSc wrappers as in step-36 (installed with PetscScalar 
> = 
> > complex) and using MappingCollection as discussed before. I now 
> try: 
> > 
> > | 
> > //static std::map bval; 
> > staticstd::mapbval; 
>
> This is unrelated to the error, but why do you make this variable 
> `static`? 
>
> > ZeroFunction   homogeneous_dirichlet_bc; 
> > 
> > consttypenameFunctionMap::type dirichlet_boundary_functions 
> > ={{types::boundary_id(0),_dirichlet_bc }}; 
>
> If you use a map for `bval` that has complex-valued keys, then you also 
> need 
> to use a FunctionMap::type object here so that the 
> boundary 
> functions are complex-valued as well. 
>
> In other words, the scalar type of the function object and of the boundary 
> values must match. 
>
> 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.
For more options, visit https://groups.google.com/d/optout.
andres.alf...@correounivalle.edu.co


Re: [deal.II] Re: mapping_collection and step-27

2017-12-01 Thread Juan Carlos Araujo Cabarcas
Thanks for your quick reply.

I used static because it was used like that in one of the steps, as there 
is no need for it, in the following it is removed.

I must admit that I am a bit lost here. However, I tried your suggestion 
and used:FunctionMap::type,  what gave the errors that 
I attach in errors.txt.
By looking at those errors, I also tried:

  std::map >  bval;

but it seems that is not the root of the problem (I also attach these 
errors at the end of the same file).

Any ideas? Thanks in advance.


El viernes, 1 de diciembre de 2017, 8:09:26 (UTC-5), Wolfgang Bangerth 
escribió:
>
> On 11/30/2017 03:05 PM, Juan Carlos Araujo Cabarcas wrote: 
> > 
> > When using the PETSc wrappers as in step-36 (installed with PetscScalar 
> = 
> > complex) and using MappingCollection as discussed before. I now 
> try: 
> > 
> > | 
> > //static std::map bval; 
> > staticstd::mapbval; 
>
> This is unrelated to the error, but why do you make this variable 
> `static`? 
>
> > ZeroFunction   homogeneous_dirichlet_bc; 
> > 
> > consttypenameFunctionMap::type dirichlet_boundary_functions 
> > ={{types::boundary_id(0),_dirichlet_bc }}; 
>
> If you use a map for `bval` that has complex-valued keys, then you also 
> need 
> to use a FunctionMap::type object here so that the 
> boundary 
> functions are complex-valued as well. 
>
> In other words, the scalar type of the function object and of the boundary 
> values must match. 
>
> 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.
For more options, visit https://groups.google.com/d/optout.


Re: [deal.II] Re: Error during p4est installation

2017-12-01 Thread Bruno Turcksin
Yaakov,

2017-12-01 8:26 GMT-05:00 :

> one is defined order p4est
> new one is p4est-build
>
p4est: directory where you wanted to install p4est
p4est-build: directory where p4est is compiled. This can be removed once
p4est is installed.
It is common when you install a library to have three directories: source
directory, build directory, and install directory

Best,

Bruno

-- 
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] Re: Spurious eigenvalues

2017-12-01 Thread Bruno Turcksin
2017-12-01 8:50 GMT-05:00 Timo Heister :

> 3. Did we rip out the support for removing the constrained entries
> from the matrix completely?

That was my plan at first using ConstraintMatix::condense but according to
the documentation, the constrained entries are not removed.

Best,

Bruno

-- 
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] Re: Spurious eigenvalues

2017-12-01 Thread Denis Davydov


On Friday, December 1, 2017 at 2:50:38 PM UTC+1, Timo Heister wrote:
>
> > They're always going to be there because we keep constrained nodes in 
> the 
> > linear system. 
>
> If we modify the way ConstraintMatrix operates, we could work around 
> this though: 
>

but there is really no need, is it? 
If you start with initial vector (or subspace, depending on the method) 
orthogonal to the constraints, you ain't gonna find converge to those 
eigenvalues anyway.

Cheers,
Denis 
 

> 1. Without rescaling those equations (as we do inside ConstraintMatrix 
> right now) the spurious EV would all be equal to 1 and so ignoring 
> them is easier. 
> 2. One could also zero out the constrained rows after the fact. 
> 3. Did we rip out the support for removing the constrained entries 
> from the matrix completely? 
>
> -- 
> 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: [deal.II] Re: Spurious eigenvalues

2017-12-01 Thread Timo Heister
> They're always going to be there because we keep constrained nodes in the
> linear system.

If we modify the way ConstraintMatrix operates, we could work around
this though:
1. Without rescaling those equations (as we do inside ConstraintMatrix
right now) the spurious EV would all be equal to 1 and so ignoring
them is easier.
2. One could also zero out the constrained rows after the fact.
3. Did we rip out the support for removing the constrained entries
from the matrix completely?

-- 
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: [deal.II] Re: Error during p4est installation

2017-12-01 Thread feapman
Hi Daniel,

Now this problem is solved. I would like to ask why I get two orders.

one is defined order p4est
new one is p4est-build

Warm regards,
Yaakov

On Friday, December 1, 2017 at 9:32:32 AM UTC+1, Daniel Arndt wrote:
>
> Yaakov,
>
> looking at p4est-install.sh, the error tells you that "SRCDIR/src/p4est.h" 
> can't be found.
> This might mean that your p4est-1.1.tar.gz is broken or incomplete.
> Can you make sure that "src/p4est.sh" indeed exists after unpacking the 
> archive?
> If not, try to download p4est-1.1.tar.gz again.
>
> Best,
> Daniel
>
> Am Freitag, 1. Dezember 2017 09:08:55 UTC+1 schrieb FEAPMAN Yaakov:
>>
>> Dear Prof. Bangerth,
>>
>> I used follwing command in terminal, and get an error report
>>
>> bash ./p4est-setup.sh p4est-1.1.tar.gz /home/feapman/Program/p4est-develop
>> CFLAGS_FAST: -O2
>> CFLAGS_DEBUG: -O0 -g
>>
>> This script tries to unpack, configure and build the p4est library.
>> Build FAST: /home/feapman/Program/p4est-build/FAST
>> Build DEBUG: /home/feapman/Program/p4est-build/DEBUG
>> Install FAST: /home/feapman/Program/p4est-develop/FAST
>> Install DEBUG: /home/feapman/Program/p4est-develop/DEBUG
>> Checking environment: CFLAGS P4EST_CFLAGS_FAST P4EST_CFLAGS_DEBUG
>> Unpack directory: /home/feapman/Program/p4est-1.1
>> Source directory found (remove it to unpack anew)
>> Error: Main header file missing
>>
>>
>> Actually,  I really need plug-in p4est as I have to use it for a used 
>> defined benchmark in Deal.II. Still Now, I have no idea how to install it.
>>
>> Warm regards,
>> Yaakov
>>
>> On Tue, Nov 28, 2017 at 6:04 AM, Wolfgang Bangerth > > wrote:
>>
>>> On 11/27/2017 08:51 PM, fea...@gmail.com wrote:
>>>

 I also get a bug when I install  p4est
 *Error: Main header file missing
 *
 How can I solve this bugs in the installation of p4est?

>>>
>>> That is not enough information for us to tell you what the problem may 
>>> be. Can you elaborate?
>>>
>>> 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 a topic in 
>>> the Google Groups "deal.II User Group" group.
>>> To unsubscribe from this topic, visit 
>>> https://groups.google.com/d/topic/dealii/2Uf6V660JtA/unsubscribe.
>>> To unsubscribe from this group and all its topics, 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] Re: Spurious eigenvalues

2017-12-01 Thread Wolfgang Bangerth

On 11/30/2017 05:47 PM, Bruno Turcksin wrote:


In step-36, there is an explanation on how Dirichlet boundary conditions 
introduce spurious eigenvalues because some dofs are constrained. However, 
there is no mention of hanging nodes. So I am wondering if I can treat them as 
shown for the Dirichlet boundary, i.e, the only difference between a hanging 
node and a Dirichlet is what happens in ConstraintMatrix::distribute().


Yes, I think this is correct -- you're going to have a row in the eigenvalue 
equation where both matrices have an entry on the diagonal. You can set these 
values to whatever you want and that's what's going to determine the size of 
the spurious eigenvalue.



I also 
wonder if there is a way to avoid having these spurious eigenvalues computed 


They're always going to be there because we keep constrained nodes in the 
linear 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 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] Re: mapping_collection and step-27

2017-12-01 Thread Wolfgang Bangerth

On 11/30/2017 03:05 PM, Juan Carlos Araujo Cabarcas wrote:


When using the PETSc wrappers as in step-36 (installed with PetscScalar = 
complex) and using MappingCollection as discussed before. I now try:


|
//static std::map bval;
staticstd::mapbval;


This is unrelated to the error, but why do you make this variable `static`?


ZeroFunction   homogeneous_dirichlet_bc;

consttypenameFunctionMap::type dirichlet_boundary_functions
={{types::boundary_id(0),_dirichlet_bc }};


If you use a map for `bval` that has complex-valued keys, then you also need 
to use a FunctionMap::type object here so that the boundary 
functions are complex-valued as well.


In other words, the scalar type of the function object and of the boundary 
values must match.


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] Re: Error during p4est installation

2017-12-01 Thread FEAPMAN Yaakov
Dear Prof. Bangerth,

I used follwing command in terminal, and get an error report

bash ./p4est-setup.sh p4est-1.1.tar.gz /home/feapman/Program/p4est-develop
CFLAGS_FAST: -O2
CFLAGS_DEBUG: -O0 -g

This script tries to unpack, configure and build the p4est library.
Build FAST: /home/feapman/Program/p4est-build/FAST
Build DEBUG: /home/feapman/Program/p4est-build/DEBUG
Install FAST: /home/feapman/Program/p4est-develop/FAST
Install DEBUG: /home/feapman/Program/p4est-develop/DEBUG
Checking environment: CFLAGS P4EST_CFLAGS_FAST P4EST_CFLAGS_DEBUG
Unpack directory: /home/feapman/Program/p4est-1.1
Source directory found (remove it to unpack anew)
Error: Main header file missing


Actually,  I really need plug-in p4est as I have to use it for a used
defined benchmark in Deal.II. Still Now, I have no idea how to install it.

Warm regards,
Yaakov

On Tue, Nov 28, 2017 at 6:04 AM, Wolfgang Bangerth 
wrote:

> On 11/27/2017 08:51 PM, feap...@gmail.com wrote:
>
>>
>> I also get a bug when I install  p4est
>> *Error: Main header file missing
>> *
>> How can I solve this bugs in the installation of p4est?
>>
>
> That is not enough information for us to tell you what the problem may be.
> Can you elaborate?
>
> 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
> rum/dealii?hl=en
> --- You received this message because you are subscribed to a topic in the
> Google Groups "deal.II User Group" group.
> To unsubscribe from this topic, visit https://groups.google.com/d/to
> pic/dealii/2Uf6V660JtA/unsubscribe.
> To unsubscribe from this group and all its topics, 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.