[deal.II] Re: Elasticity

2016-06-14 Thread benhour . amirian66
Dear all,
Thanks very much for your response and help. If I can make it simple, in my 
equation, the lame constants in stress-strain tensor are related to another 
function that changes with solution vector. For instance, consider a 
situation in which you have a constant rank-2 tensor for initial strain 
with this assumption that the indices of the matrix are multiplied by a 
function of solution vectors. My question is that how can I define such a 
matrix in deall ii because of the fact that all of my equations are almost 
related to this interpolation function. Looking forward  to hearing from 
you. I do really appreciate that.

Best,
Benhour

On Monday, June 13, 2016 at 8:30:40 AM UTC-5, benhour@gmail.com wrote:
>
> Dear all,
>
> In step 18, the elasticity problem has been solved with this assumption 
> that there was not initial strain in the equation. I want to add the 
> initial strain with consideration of the fact that this tensor is a 
> function of the solution. In other words, this tensor should be 
> multiplied by a function that is related to the solution vectors. It  would 
> be very kind of you if you help what is the best way to introduce this  
> additional 
> term in the equation. I do really appreciate your kindness and your time 
> you can answer to my question. Looking
> forward to hearing from you.
>
> Thanks,
> Benhour
>

-- 
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] Elasticity

2016-06-13 Thread benhour . amirian66
Dear all,

In step 18, the elasticity problem has been solved with this assumption 
that there was not initial strain in the equation. I want to add the 
initial strain with consideration of the fact that this tensor is a 
function of the solution. In other words, this tensor should be multiplied 
by a function that is related to the solution vectors. It  would be very 
kind of you if you help what is the best way to introduce this  additional 
term in the equation. I do really appreciate your kindness and your time 
you can answer to my question. Looking
forward to hearing from you.

Thanks,
Benhour

-- 
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] Derivative of a scalar function in the code

2016-08-14 Thread benhour . amirian66
Dear All,
I want to extract the first derivative and the gradient of a scalar 
function in dealii. Maybe I should use the void FEValuesViews::Scalar 
<
 
dim, spacedim >::get_function_gradients. However, I really do not kn ow how 
I should use it in a real code. I do really appreciate it if you help me to 
write it.

Best,
Benhour

-- 
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: geometry

2016-07-16 Thread benhour . amirian66
Daniel,
In that code, I had a half circle in the right part of the coordinate axis. 
By writing v(1) <=0, I wanted to choose the part with negative y components 
from the geometry, however, The attached file has been obtained. I really 
do not know how I should modify the source you sent to me because of the 
fact that my knowledge about deal ii is rudimentary now and I am trying 
hard to learn this open source library. It would be very kind of you if you 
help me about this software.

Best,
Benhour



On Saturday, July 16, 2016 at 3:44:42 AM UTC-5, Daniel Arndt wrote:
>
> Benhour,
>
> It would be helpful if you tell us what the problem with the newly created 
> problem is.
> Looking at the implementation of GridGenerator::half_hyper_ball [1],
> you can observe that there are cells which have vertices both with 
> positive and negative
> y-components. This will likely lead to undesired results just deleting 
> cells.
>
> It might still be easiest to modify [1] yourself for your purpose.
>
> Best,
> Daniel
>
> [1] 
> https://www.dealii.org/8.4.0/doxygen/deal.II/grid__generator_8cc_source.html
>
>
>
> Am Samstag, 16. Juli 2016 04:10:33 UTC+2 schrieb benhour@gmail.com:
>>
>> Dear J-P,
>> Thanks for your response. I used the code for creating a quarter of a 
>> circle that comes as follow:
>>
>> Triangulation<2> triangulation;
>> const Point<2> center;
>> const double radius = 1.;
>> GridGenerator::half_hyper_ball(triangulation, center, radius);
>>
>> Triangulation<2>::active_cell_iterator
>> cell = triangulation.begin_active(),
>> endc = triangulation.end();
>> std::set::active_cell_iterator> remove;
>> // Triangulation<2>::active_cell_iterator cell;
>> for (cell=triangulation.begin_active(); cell!=triangulation.end(); ++cell)
>> {
>> Point<2> v=cell->center();
>> // If it is in the bottom part of the geometry, remove it
>> if (v(1) <= 0)
>> remove.insert(cell);
>> }
>>  // remove the marked cells
>>  GridGenerator::create_triangulation_with_removed_cells(triangulation, 
>> removal, triangulation);
>>
>> Unfortunately, It does not create the right geometry. I do really 
>> appreciate your kindness if you let me know which parts of this code go 
>> wrong. Looking forward to hearing from you.
>>
>> Best,
>> Benhour
>>
>> On Wednesday, July 13, 2016 at 6:15:04 AM UTC-5, Jean-Paul Pelteret wrote:
>>>
>>> Dear Benhour,
>>>
>>> You could use one of the GridGenerator options to create a half circle, 
>>> and then use GridGenerator::create_triangulation_with_removed_cells 
>>> 
>>>  to 
>>> remove the excess cells that yo udon't want.
>>>
>>> Regards,
>>> J-P
>>>
>>> On Wednesday, July 13, 2016 at 3:40:02 AM UTC+2, benhour@gmail.com 
>>> wrote:

 Dear All,
 I want to create a quarter of a circle in deal ii. In  this case, I 
 could create half of a circle with half_hyper_ball. I have tried 
 GridTools::delete_unused_vertices or GridTools::transformation to remove 
 or 
 shift the same vertices to eliminate half of the circle. It would be very 
 kind of you if you let me know how to define this geometry in Dealii. It 
 should be noted that I also used quarter_hyper_shell and put inner radius 
 to zero but it did not work for this case.

 Best,
 Benhour

>>>

-- 
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.


grid-3.eps
Description: PostScript document


[deal.II] Geometry and boundary conditions

2016-07-06 Thread benhour . amirian66
Dear All,
I want to define a new geometry (a quarter of a circle) and apply symmetry 
boundary condition on two sides of the quarter. It would be very kind of 
you if you help me for that.

Best,
Benhour

-- 
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] Tensor with variable components

2016-09-02 Thread benhour . amirian66
Dear All,
I have a question. I want to define a tensor with components like the below 
expression, where eta is a scalar function in cylindrical coordinate 
system. I defined this component in dealii like this:
FE_Qfe
  const QGauss quadrature_formula(3)
  FEValues fe_values (fe, quadrature_formula,
update_gradients| 
update_quadrature_points);
  const unsigned int n_q_points = 
quadrature_formula.size();
  std::vector< Tensor<1, dim> > 
eta_gradients(n_q_points);
  std::vector< Tensor<2, dim> > 
eta_hessians(n_q_points);
  fe_values.get_function_gradients(eta_gradients);
  fe_values.get_function_hessians(eta_hessians);
  for(unsigned int q_point = 0; q_point < 
n_q_points; ++q_point)
 
  const double comp11 = std::pow(eta, 2)*
   std::pow((1-eta), 2)+(eta_hessians[q_point][0] +
   eta_hessians[q_point][1]) - eta_gradients[q_point][0] *
   eta_gradients[q_point][0];
I do really appreciate it if you let me know whether this part of code for 
the following component is true or not.

.  


-- 
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: Defining tensor in different dim and spacedim

2016-10-19 Thread benhour . amirian66
Dear All,
I still have some problem in solving my equations on a curved domain 
(sphere in 3D or circle in 2D). I got error with this content:
invalid initialization of reference of type ‘dealii::Triangulation<2, 3>&’ 
from expression of type ‘dealii::Triangulation<3, 3>’
Does it mean that I should use different codim for my domain and Finite 
element spaces because of the fact that I should solve my problem and 
impose my boundary condition on a sphere.

Thanks,
Benhour

On Wednesday, October 19, 2016 at 4:43:59 PM UTC-5, Wolfgang Bangerth wrote:
>
> > In fact, I should solve my problem on a sphere (circle). According to 
> your 
> > noteworthy comments, the only thing that I have to do is change the 
> geometry 
> > and use higher order mapping for accuracy. Another thing is that 
> consider a 
> > half of a circle in r-z coordinate system and the problem is 
> axisymmetric. 
> > what should be my boundary condition for rotation axis (z-coordinate)? 
>
> That depends on the equation, but if you were, for example, solving the 
> Laplace equation in cylindrical coordinates, then there would be no 
> special 
> boundary condition along the z-axis (at r=0). That's because you will find 
> that when you do the integration by parts, you get boundary terms of the 
> form 
>
>\int_{\partial \Omega}   n.nabla u(r,z)  varphi(r,z)  2*pi*r  dr  dz 
>
> But at the symmetry axis, r=0, so the integrand disappears at the 
> boundary. 
>
> In other words, for most equations, there is nothing special you need to 
> do at 
> the symmetry axis. 
>
> 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: Defining tensor in different dim and spacedim

2016-10-22 Thread benhour . amirian66
Dear All,
I want to solve my thermoelasticity problem in cylindrical coordinate 
systems. my domain includes two quarter of a circle in 2D and two quarter 
of two spheres in 3D. They are bulk. I attached my domain that was created 
by quarter_hyper_shell for 2D. But, I really do not kno how I can create it 
in 3D. It would be very kind of you if you help me to create my geometry 
according to the fact that the hyper_sphere only sxists in dim=spacedim + 
1, so by considering this assumption, what changes should i impose on my 
equation? Should I change my DoFHandler or Trian gulation as well?

Bests,
Benhour  

On Thursday, October 20, 2016 at 9:54:06 PM UTC-5, Wolfgang Bangerth wrote:
>
> On 10/19/2016 08:42 PM, benhour@gmail.com  wrote: 
> > I still have some problem in solving my equations on a curved domain 
> (sphere 
> > in 3D or circle in 2D). I got error with this content: 
> > invalid initialization of reference of type ‘dealii::Triangulation<2, 
> 3>&’ 
> > from expression 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 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] Defining tensor in different dim and spacedim

2016-10-18 Thread benhour . amirian66
Dear All,
I am solving an elastic problem coupled with heat equation transfer 
(thermal-elasticity). I should solve the problem in a curved domain (circle 
in 2d and sphere in 3d) . I am developing step 44 in this case. I have to 
define some symmetric tensors. I have attached some parts of my code that i 
have problem with. I have two unknown variables. one for displacement 
(vector) and another for other parameter(scalar). I do really appreciate 
your kindness if you let me know how I can define symmetric tensor or in 
general tensor for this case. In addition, should I define DofHandler for both scalar and vector valued unknown? My main problem is how 
to define tensor in different dim and spacedim problem.

   template 
   class PointHistory
  {
   public:
   PointHistory()
 :
   material(NULL),
  F_inv(StandardTensors::I),
  elasStress(SymmetricTensor<2, spacedim>()),
  totalStress(SymmetricTensor<2, spacedim>()),
  Jc(SymmetricTensor<4, spacedim>())
 {}

virtual ~PointHistory()
  {
delete material;
material = NULL;
  }

void setup_lqp (const Parameters::AllParameters )
  {
material = new Material_Variables(parameters.lambda0,
parameters.mu0, parameters.lambda1, parameters.mu1, 
parameters.chi, parameters.H,
parameters.thetain, parameters.thetacr, parameters.thetaeq, 
parameters.theta, parameters.gammasv);

update_values(Tensor<2, dim>(), double ());
  }

void update_values (const Tensor<2, dim> _u_n, const double eta
)
  {
const Tensor<2, dim> eps = 0.5 * (Grad_u_n + 
transpose(Grad_u_n));// Total 
Strain


const double phi = std::pow(eta, 2) * (3 - 2 * eta);   
  // Function 
of order parameter
dphi = 6 * eta * (1 - eta); 
// 
Derivative of the interpolation function
const double doubleWellBarrier = 2*eta + 4 * std::pow(eta, 3) - 
6*std::pow(eta, 2);
const double etaBVG = -6 * chi1 * delg1 * (1+eps_V) * dphi; 
// Boundary value for 
G-L equation
const double etaBVM = 2 * gam1 / 30e-9; // Boundary value for 
Mechanics

// Thermal Strain Tensor
   const SymmetricTensor<2, dim> epsThermal = alphas * (thetaeq1 - 
thetain1) * StandardTensors::I +
   (alpham + (alphas - alpham) * phi) * (theta1 - thetaeq1) * 
StandardTensors::I;

// Transformation Strain Tensor
   const SymmetricTensor<2, dim> epsTransformation = (1.0/3.0) * 0.02 * 
StandardTensors::I *
   (1 - phi);
//The Initial Strain
   const SymmetricTensor<2, dim> epsInitial = SymmetricTensor<2, 
dim>(epsThermal) +
(1-phi) * 0.02 * StandardTensors::I;

// Elastic Strain Tensor
   const SymmetricTensor<2, dim> epsElastic = symmetrize(Tensor<2, 
dim>(eps)-
  SymmetricTensor<2, 
dim>(epsTransformation)-
  SymmetricTensor<2, 
dim>(epsInitial) -
  SymmetricTensor<2, dim>(epsThermal));
// The Deviatoric Strain
const SymmetricTensor<2, dim> epsDeviatoric = symmetrize(Tensor<2, 
dim>(eps)-(1.0/3.0) * eps_V*
   StandardTensors::I);

   material->update_material_data(F, eps, phi, dphi, doubleWellBarrier, 
etaBVG, etaBVM
);
   F_inv = invert(F);
   eps_V = material->get_eps_V();
   elasStress = material->get_elasStress();
//surfTenStress = material->get_surfTenStress();   // It is exactly 
equal to initial stress...
   totalStress = material->get_totalStress();   // Extracting total 
Cauchy stress
   Jc = material->get_Jc(); 
// Extracting elasticity stiffnes tensor
   driving_force_noStress = material->get_driving_force_noStress();   
// Extracting driving force with no stress

   eta_boundary_valueG = material->get_eta_boundary_valueG();   
   // Extracting the boundary value for G-L equation
eta_boundary_valueM = material->get_eta_boundary_valueM(); 
  // Extracting the boundary value for 
mechanics

   const double temp = -(1.0/(1+eps_V))*0.02*mean_elas_stress;
   const double temp1 = temp + 3*(1.0/(1+eps_V))*mean_elas_stress*
   (alphas - alpham)*(theta1 - thetaeq1);
   const double temp2 = temp1 - ((1.0/(1+eps_V))*(0.5*(lambda1-lambda0)*
  SymmetricTensor<2, dim>(epsElastic) * 
SymmetricTensor<2, dim>(epsElastic)));
   const double temp3 = 

[deal.II] Error with the content "dealii::numbers::is_finite(sum)"

2016-10-25 Thread benhour . amirian66
Dear All,
I am solving a thermoelastic problem in cylindrical coordinate system. I 
used CG solver for thermal problem and Newton-Raphson method for elasticity 
section. For solving linear system, I used direct solver 
SparseDirectUMFPACK with SSOR as a preconditioner. Unfortunately, I got 
some errors as follow:

 * dealii::Vector::real_type dealii::Vector::norm_sqr() 
const [with Number = double; dealii::Vector::real_type = double]*
*MPI_ABORT was invoked on rank 0 in communicator MPI_COMM_WORLD *
*The violated condition was: *
*with errorcode 59.*
*dealii::numbers::is_finite(sum)*

*The name and call sequence of the exception was:*
*NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes.*
*ExcNumberNotFinite(std::complex(sum))* 

It would b very kind of you if someone told me what is wrong with my code.

Bests,
Benhour

-- 
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: Defining tensor in different dim and spacedim

2016-10-19 Thread benhour . amirian66
Yes You are right. I mean curved domain. My question is should i use codim 
instead of mapping because of the fact that there is only two tutorials in 
dealii which solved a differential equation on c curved domain according to 
the fact that my derived weak expressions are in cylindrical coordinate 
systems?

Thanks,
Benhour

On Wednesday, October 19, 2016 at 1:04:04 PM UTC-5, Timo Heister wrote:
>
> > Let me put it in a such way. I want to solve my equation on a curved 
> edge. 
> > According to dealii library, I should use MappingQ whenever I have 
> nonlinear 
> > domain. Am I correct? 
>
> I don't think "nonlinear" is the word you are looking for. Do you mean 
> a curved boundary? 
>
> > In addition, Should I replace all dim in defining my 
> > tensors to spacedim? It should be noted that dim = spacedim - 1. 
>
> Using a mapping (see step-10, step-11, etc.) has nothing to do with 
> codim 1 or 2 problems (where dim is not equal to spacedim, see 
> step-38). 
>
> -- 
> 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.


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

2016-10-19 Thread benhour . amirian66
Dear Jean-Paul,
Let me put it in a such way. I want to solve my equation on a curved edge. 
According to dealii library, I should use MappingQ whenever I have 
nonlinear domain. Am I correct? In addition, Should I replace all dim in 
defining my tensors to spacedim? It should be noted that dim = spacedim - 1.

Best,
Benhour 

On Wednesday, October 19, 2016 at 1:41:33 AM UTC-5, Jean-Paul Pelteret 
wrote:
>
> Dear Benhour,
>
> Thank you for providing a little more context, but you still have not 
> articulated what the actual problem is. What exactly do you mean by "I have 
> some problem with defining elasticity matrices"?
>
> Please see this post 
> , in 
> particular the section titled "*How to best formulate a question*".
>
> Regards,
> J-P
>

-- 
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: Defining tensor in different dim and spacedim

2016-10-19 Thread benhour . amirian66
Yes exactly. The only difference is in weak form of my equation which 
should be multiplied by 2*pi*r which I define r_value = 
fe_values_eta.quadrature_point(q_point)[0];
In fact, I should solve my problem on a sphere (circle). According to your 
noteworthy comments, the only thing that I have to do is change the 
geometry and use higher order mapping for accuracy. Another thing is that 
consider a half of a circle in r-z coordinate system and the problem is 
axisymmetric. what should be my boundary condition for rotation axis 
(z-coordinate)? For the r-coordinate, I can use no-normal flux boundary 
conditions or just limit the displacement normal to the surface, however, 
for rotation axis I am really confused. 

On Wednesday, October 19, 2016 at 1:50:49 PM UTC-5, Timo Heister wrote:
>
> > Yes You are right. I mean curved domain. My question is should i use 
> codim 
> > instead of mapping because of the fact that there is only two tutorials 
> in 
> > dealii which solved a differential equation on c curved domain according 
> to 
>
> No, codim problems solve systems on surfaces embedded in a higher 
> dimensional space. This has nothing to do with solving on a domain 
> that is not a rectangle. There are other examples that use a different 
> domain, see step-32 for example. 
>
> > the fact that my derived weak expressions are in cylindrical coordinate 
> > systems? 
>
> Are you sure you want to describe your problem in cylindrical 
> coordinates? While possible, this probably only makes sense if you 
> have additional symmetries in your system that you want to exploit, 
> but you will have many other issues with that (quadrature etc.). 
>
> If you just want to solve on a disk or sphere, you just need to change 
> the geometry and potentially use a higher order mapping for accuracy. 
>
> > 
> > Thanks, 
> > Benhour 
> > 
> > 
> > On Wednesday, October 19, 2016 at 1:04:04 PM UTC-5, Timo Heister wrote: 
> >> 
> >> > Let me put it in a such way. I want to solve my equation on a curved 
> >> > edge. 
> >> > According to dealii library, I should use MappingQ whenever I have 
> >> > nonlinear 
> >> > domain. Am I correct? 
> >> 
> >> I don't think "nonlinear" is the word you are looking for. Do you mean 
> >> a curved boundary? 
> >> 
> >> > In addition, Should I replace all dim in defining my 
> >> > tensors to spacedim? It should be noted that dim = spacedim - 1. 
> >> 
> >> Using a mapping (see step-10, step-11, etc.) has nothing to do with 
> >> codim 1 or 2 problems (where dim is not equal to spacedim, see 
> >> step-38). 
>
>
> -- 
> 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.


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

2016-10-18 Thread benhour . amirian66
Dear All,
I want to solve a thermoelastic problem in cylindrical coordinate system. 
My domain is a circle in 2D or Sphere in 3D. I am following step 44 with 
considering the fact that I am solving for small strain. Because I have 
curved domain and I should Impose a boundary condition that change with 
temperature on the curved side of my domain, I understood that I should use 
MappingQ because of the fact that my whole domain includes curved edge. For 
this case, I have some problem with defining elasticity matrices such as 
thermal, initial and elastic strain along with stresses. I have attached my 
code for your consideration. It would be very kind of you if you take a 
glance at it and tell me what is wrong defining my matrices.

On Tuesday, October 18, 2016 at 2:27:17 PM UTC-5, Jean-Paul Pelteret wrote:
>
> Dear Benhour,
>
> I'd like to help you but I really don't understand your question. Since 
> its templated on the [space] dimension, the PointHistory class that you've 
> displayed here is potentially suitable for either codimension 0 problems 
> (dependent on your implementation of a constitutive law, of course, and 
> assuming that you swap all instances of "dim" for the template parameter 
> "spacedim"). Can you please try to explain a little more clearly what you 
> are trying to do and what the issue is, and give some more context to the 
> code you've quoted?
>
> - Are you solving your problem in the "standard" setting (either dim=1,2 
> or 3), or the codimension 1 case (e.g. a 2-d manifold embedded in 3d 
> space)? Or does one of your field variables only correspond to the 
> codimension 1 case?
> - Are you referring to some structures that store, for example, the 
> kinematic variables for both fields as well as the tangents resulting from 
> linearisation of the coupled problem?
> - Are you solving your problem using a staggered scheme? I ask because you 
> store neither any of the kinematic data nor tangents related to the thermal 
> problem or coupling.
>
> Have you examined the many tutorials that solve problem with multiple 
> fields/components? They may not be multi-physics *per se*, but will give 
> you some insights on how to set up your problem.
>
> Regards,
> J-P
>
> On Tuesday, October 18, 2016 at 6:31:30 PM UTC+2, benhour@gmail.com 
>  wrote:
>>
>> Dear All,
>> I am solving an elastic problem coupled with heat equation transfer 
>> (thermal-elasticity). I should solve the problem in a curved domain (circle 
>> in 2d and sphere in 3d) . I am developing step 44 in this case. I have to 
>> define some symmetric tensors. I have attached some parts of my code that i 
>> have problem with. I have two unknown variables. one for displacement 
>> (vector) and another for other parameter(scalar). I do really appreciate 
>> your kindness if you let me know how I can define symmetric tensor or in 
>> general tensor for this case. In addition, should I define DofHandler> spacedim> for both scalar and vector valued unknown? My main problem is how 
>> to define tensor in different dim and spacedim problem.
>>
>>template 
>>class PointHistory
>>   {
>>public:
>>PointHistory()
>>  :
>>material(NULL),
>>   F_inv(StandardTensors::I),
>>   elasStress(SymmetricTensor<2, spacedim>()),
>>   totalStress(SymmetricTensor<2, spacedim>()),
>>   Jc(SymmetricTensor<4, spacedim>())
>>  {}
>>
>> virtual ~PointHistory()
>>   {
>> delete material;
>> material = NULL;
>>   }
>>
>> void setup_lqp (const Parameters::AllParameters )
>>   {
>> material = new 
>> Material_Variables(parameters.lambda0,
>> parameters.mu0, parameters.lambda1, parameters.mu1, 
>> parameters.chi, parameters.H,
>> parameters.thetain, parameters.thetacr, parameters.thetaeq, 
>> parameters.theta, parameters.gammasv);
>>
>> update_values(Tensor<2, dim>(), double ());
>>   }
>>
>> void update_values (const Tensor<2, dim> _u_n, const double 
>> eta
>> )
>>   {
>> const Tensor<2, dim> eps = 0.5 * (Grad_u_n + 
>> transpose(Grad_u_n));// Total 
>> Strain
>>
>>
>> const double phi = std::pow(eta, 2) * (3 - 2 * eta); 
>> // Function 
>> of order parameter
>> dphi = 6 * eta * (1 - eta);   
>>   
>> // Derivative of the interpolation function
>> const double doubleWellBarrier = 2*eta + 4 * std::pow(eta, 3) 
>> - 6*std::pow(eta, 2);
>> const double etaBVG = -6 * chi1 * delg1 * (1+eps_V) * dphi;   
>>   // Boundary value for 
>> G-L equation
>> 

Re: [deal.II] Re: Apply Neumann Boundary condition

2016-12-06 Thread benhour . amirian66
Dear Jean,
Thanks very much for your help and support. Most of my problem is related 
to applying axisymmetry boundary condition for a curved domain. I attached 
my code for your consideration. According to the fact that this is my first 
project with dealii, Please accept my lack of knowledge in this case. This 
is a themo-elastic problem for a curved domain which for getting result, I 
have fixed the straight line of my domain. However, I really do not know 
why the Neumann boundary condition which is brought in the 
assemble-system-rhs does not work properly, instead of putting force on the 
curved domain, it seems that it is a tensile force. It should be noted that 
I have changed the sign of my equation for this type of boundary condition, 
however, it  still has not worked properly. Your noteworthy comments on my 
code can give me incredible experiences on working with dealii. Looking 
forward to hearing from you.

Bests,
Benhour

On Monday, December 5, 2016 at 5:01:25 AM UTC-6, Jean-Paul Pelteret wrote:
>
> Dear Benhour,
>  
>
>> These are 9 concepts, in 9 lines of text, all without any kind of 
>> elaboration. 
>> In other words, we have no real idea what you are doing, and equally 
>> important, we have no idea what is actually wrong. When debugging 
>> problems 
>> like yours, you need to learn to reduce things to the minimal case that 
>> shows 
>> the problem, and to look for the *first sign* where something seems to be 
>> going wrong. 
>
>
> Prof Bangerth has succinctly stated why I'm having such difficulties in 
> helping you. 
>
> I, like him, would encourage you to take your code and strip out as many 
> of the complexities as possible, and produce some test cases that convince 
> you that each part of your code is working as expected. This is exactly how 
> I build up any of my codes that tackle complex problems. For this you often 
> need to test your implementation of each "feature" against a really simple 
> problem that you can hand calculate a comparison result for, or otherwise 
> some benchmark in the literature.
>
> Thats really the best advice we can give you in this instance. So, for 
> example, coming back to your question of the implementation of the traction 
> boundary condition: you could easily test this by considering a distributed 
> load on a bar (inducing uni-axial tension) or perhaps the result shown in 
> step-44  or 
> one of the more simple code-gallery examples 
> 
> .
>
> Regards,
> Jean-Paul
>

-- 
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.
/* -
 *
 * Copyright (C) 2000 - 2015 by the deal.II authors
 *
 * This file is part of the deal.II library.
 *
 * The deal.II library is free software; you can use it, redistribute
 * it, and/or modify it under the terms of the GNU Lesser General
 * Public License as published by the Free Software Foundation; either
 * version 2.1 of the License, or (at your option) any later version.
 * The full text of the license can be found in the file LICENSE at
 * the top level of the deal.II distribution.
 *
 * -

 *
 * Author: Wolfgang Bangerth, University of Heidelberg, 2000
 */


// Just as in previous examples, we have to include several files of which the
// meaning has already been discussed:
#include 
#include 
#include 
#include 
#include 
#include 
#include 
#include 
#include 
#include 
#include 

#include 
#include 
#include 
#include 
#include 
#include 
#include 
#include 
#include 
#include 
#include 
#include 

#include 
#include 
#include 
#include 
#include 
#include 

#include 
#include 
#include 
#include 

#include 
#include 
#include 
#include 
#include 
#include 
#include 
#include 

#include 
#include 
#include 


#include 
#include 

namespace Melting
{
  using namespace dealii;
  namespace Parameters
  {

/
   struct MaterialVariables
 {
   double lambda0;  // Bulk modulus of liquid phase
   double lambda1;  // Bulk modulus of solid phase
   double mu1;  // Shear modulus of solid phase (The shear modulus of liquid phase is assumed to be zero)

   static void
   declare_parameters(ParameterHandler );
   void
   parse_parameters(ParameterHandler );
 };

   void MaterialVariables::declare_parameters(ParameterHandler )
 {
  

[deal.II] Re: Neumann boundary condition for the curved domain

2016-12-09 Thread benhour . amirian66
Dear Wolfgang,
It should not be zero. In addition, the local quadrature point is for the 
cell.

Thanks,
Benhour

On Thursday, December 8, 2016 at 8:16:03 PM UTC-6, benhour@gmail.com 
wrote:
>
> Dear All,
> I still have problem with implying boundary condition on the curved 
> domain. consider we produce quarter of a ring in 2D with the function 
> "quarter_hyper_shell" and want to impose Neumann boundary condition on the 
> outer surface. In fact we have a force normal to this surface. The other 
> boundary conditions for straight lines are axisymmetry boundary condition. 
> What I did is given as follow:
>
>   for (unsigned int face=0; faceif (cell->face(face)->at_boundary() == true
>&& cell->face(face)->boundary_id() == 11)
>  {
> scratch.fe_face_values_ref.reinit(cell, face);
> for (unsigned int f_q_point=0; f_q_point {
>const double time_ramp = (time.current() / time.end());
>const double eta_orderM = 
> (local_quadrature_point_history[f_q_point].get_eta_boundary_value_mechanic()) 
> * time_ramp;   *// The multiplication of Neumann value (for example heat 
> flux in heat equation or traction force normal to the surface in mechanic) 
> and time_ramp*.
>static const Tensor<1, dim> normals = 
> scratch.fe_face_values_ref.normal_vector(f_q_point); * // Extracting the 
> normal vectors of the selected face*
>const Tensor<1, dim> neumann_value = eta_orderM * normals;
>
> for (unsigned int i=0; i {
>  const unsigned int i_group =fe.system_to_base_index(i).first.first;
>  if (i_group == u_dof)
>{
>   const unsigned int component_i = 
> fe.system_to_component_index(i).first;
>   const double JxW = scratch.fe_face_values_ref.JxW(f_q_point);
>   data.cell_rhs(i) -= neumann_value[component_i] * 
> scratch.fe_face_values_ref.shape_value(i, f_q_point) * JxW;
>}
> }
>}
>  }
> The problem is that with changing the sign of the data.cell_rhs(i), the 
> direction of the force did not change. In fact, The ring is under 
> compression, however, in the result, it seems that it is under tension. It 
> would be very kind of you if you tell me which part I am making mistake. I 
> know this website is not for code reviewing, but I really appreciate your 
> time and help.
>
> Bests,
> Benhour
>

-- 
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] distributed body force

2016-12-13 Thread benhour . amirian66
Dear All,
It would be very kind of you if you let me know how I can imply distributed 
load on the inner radius of a ring instead of using nodal load.

Thanks,
Benhour

-- 
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] general question

2016-12-06 Thread benhour . amirian66
Dear All,
I hope you have had a great time. I have a general question. I define total 
strain and deviatoric part of the elastic strain tensor in two different 
ways as below:

1- Total strain tensor:
const SymmetricTensor<2, dim> total_strain = 0.5*(Grad_u + 
transpose(Grad_u));   (Tensor<2, dim> _u)

const SymmetricTensor<2, dim> total_strain = symmetrize(Grad_u);

2-Deviatoric strain
dev_T_elastic =  deviator(T_elastic);

dev_T_elastic = T_elastic - (1/dim) * trace(T_elastic) * (Tensor<2, 
dim>(StandardTensors::I))/3.0;

It is interesting that I got two different results for each case. I would 
be very kind of you if you let me know what is the difference between each 
case of the two above section.

Thanks,
Benhour

-- 
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] Apply Neumann Boundary condition

2016-12-01 Thread benhour . amirian66
Dear All,
I want to apply non-zero neumann boundary condition on the curved domain of 
half of the circle. The way that I define my geometry, the boundary id and 
apply the Neumann B.C is written as follow:

*Defining boundary id for different sections of domain (half_hyper_ball):*

const double tol_boundary = 1e-12
for (typename Triangulation ::active_cell_iterator
cell=triangulation.begin_active();
cell!=triangulation.end(); ++cell)
for (unsigned int face=0; faceface(face)->at_boundary() == true)
 {
   const Point face_center = cell->face(face)->center();
   if 
(std::abs(std::sqrt(face_center[0]*face_center[0]+face_center[1]*face_center[1])
  - radius) < tol_boundary)
  cell->face(face)->set_boundary_id (2); // faces on the outer 
curved edge of the domain...
   else
cell->face(face)->set_boundary_id (1);

*// Implying the mechanical boundary value to the curved surface of the 
domain that appears on the right hand side *

for (unsigned int face=0; faceface(face)->at_boundary() == true
  && cell->face(face)->boundary_id() == 2)
   {
scratch.fe_face_values_ref.reinit(cell, face);
for (unsigned int f_q_point=0; f_q_point neumann_value = eta_orderM * 
scratch.fe_face_values_ref.normal_vector(f_q_point);
  const unsigned int component_i = 
fe.system_to_component_index(i).first;
  const double JxW = scratch.fe_face_values_ref.JxW(f_q_point);
  data.cell_rhs(i) += neumann_value[component_i] * 
scratch.fe_face_values_ref.shape_value(i, f_q_point) * JxW;
 }
   }
 }
   }
It would be very kind of you if you let me know whether this definition for 
the Neumann boundary condition on the curved side of my domain is true or 
not.
Bests,
Benhour

-- 
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: Apply Neumann Boundary condition

2016-12-01 Thread benhour . amirian66
Dear Jean,
I know that this website is not the code reviewer. I want to apply Neumann 
boundary condition on the curved side of my domain. It should be note that 
the domain is symmetry. I have considered half of a circle. It would be 
very kind of you if you let me know whether it is applied correctly because 
I think something is wrong when I run my code and my domain completely 
distorted. I am doubtful about how I applied the boundary condition. For 
the horizontal axis, I have considered the zero displacement along y-axis 
because of symmetry. Is it correct? Should I fix the center of the circle 
as well? How Can I do that? In other words, How can I fix one point 
(vertex) in 2-D? Looking forward to hearing from you. 

On Thursday, December 1, 2016 at 3:54:44 PM UTC-6, Jean-Paul Pelteret wrote:
>
> Dear Benhour,
>
> As I explained to someone else 
> 
>  
> the day before yesterday, the point of this forum is not to provide a code 
> review service without you having done due diligence on your side. Does 
> this not work as expected? If this is the case, then how is the problem 
> manifesting itself? Unless you have a specific issue pertaining to the code 
> that you have posted then I'm afraid that there's no discussion to be had 
> here.
>
> Regards,
> Jean-Paul
>

-- 
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: Apply Neumann Boundary condition

2016-12-02 Thread benhour . amirian66
Dear Jean,
Thanks very much for your help and support. I do really appreciate your 
time and know you are really busy. The fact is that my code ran just for 
the first time step and can not solve for the other time step. when I 
refine the global mesh twice, this problem happened, however, with 
increasing the number of global refine mesh, the whole geometry is 
distorted. In fact, it is a thermo-elastic problem which I should use two 
different Neumann B.C for the curved side of my domain. I just want to know 
whether applying this type was true or not. In addition, could you please 
help me more how I should use load-following algorithm in dealii? It should 
be noted that I have multiplied the Neumann magnitude by time-ramp 
(current_time/time_step). Looking forward to hearing from you.

On Friday, December 2, 2016 at 12:50:03 AM UTC-6, Jean-Paul Pelteret wrote:
>
> Dear Benhour,
>
> Thank you for taking my point heart and providing more specifics about 
> your actual problem.
>
> For the horizontal axis, I have considered the zero displacement along 
>> y-axis because of symmetry. Is it correct? Should I fix the center of the 
>> circle as well? 
>>
>
> If you don't provide at least one Dirichlet constraint for each of the 
> solution components then your problem is indeterminate. So if you only 
> constrain the x-DoFs along the y-axis and have no other Dirichlet 
> constraints then this could be the source of some troubles. 
>  
>
>> How Can I do that? In other words, How can I fix one point (vertex) in 
>> 2-D? 
>>
>
> You have to manually add such a point constraint to the constraint matrix 
> or map of boundary values. If your centre point is coincident with a vertex 
> of the triangulation then you can achieve this with the help of the 
> cell->vertex_dof_index() function. There have been plenty of posts 
> 
>  
> in the past on how this function works, so I need not explain it again in 
> detail.
>
> I should also note that for highly nonlinear problems, if your load 
> increment is too large between time steps then this could also be 
> problematic (unless you're using a load-following algorithm like the 
> arc-length method). It may be of use to reduce the magnitude of the applied 
> traction while you're debugging this.
>
> Regards,
> Jean-Paul
>

-- 
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: Step-42

2017-05-14 Thread benhour . amirian66
Hi Daniel,
I tried with version 8.4.1 and also the new version, 8.5, however it does 
not run at all. The errors that I got are given as below:
make[3]: *** [CMakeFiles/run] Error 1
make[2]: *** [CMakeFiles/run.dir/all] Error 2
make[1]: *** [CMakeFiles/run.dir/rule] Error 2
make: *** [run] Error 2

Thanks,
Ben

On Sunday, May 14, 2017 at 5:25:36 PM UTC-5, Daniel Arndt wrote:
>
> Ben,
>
> 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.
>>
> Which version of deal.II are you using? Can you provide us with the errors 
> you get?
>
> 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] 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.


[deal.II] Re: Step-42

2017-05-15 Thread benhour . amirian66
Dear Daniel,
According to your noteworthy comments, I tried exactly what you said, 
however, I got exactly the same as before, as what you got.

Thanks,
Benhour

On Monday, May 15, 2017 at 12:23:44 PM UTC-5, Daniel Arndt wrote:
>
> Benhour,
>
> `make run` gives me:
>
> Scanning dependencies of target step-42
> [ 33%] Building CXX object CMakeFiles/step-42.dir/step-42.cc.o
> [ 66%] Linking CXX executable step-42
> [ 66%] Built target step-42
> Scanning dependencies of target run
> [100%] Run step-42 with Debug configuration
> *** Call this program as <./step-42 input.prm>
> CMakeFiles/run.dir/build.make:57: recipe for target 'CMakeFiles/run' failed
> make[3]: *** [CMakeFiles/run] Error 1
> CMakeFiles/Makefile2:259: recipe for target 'CMakeFiles/run.dir/all' failed
> make[2]: *** [CMakeFiles/run.dir/all] Error 2
> CMakeFiles/Makefile2:266: recipe for target 'CMakeFiles/run.dir/rule' 
> failed
> make[1]: *** [CMakeFiles/run.dir/rule] Error 2
> Makefile:196: recipe for target 'run' failed
> make: *** [run] Error 2
>
> which is at least similar to what you are observing. The relevant line 
> here is:
> *** Call this program as <./step-42 input.prm>
>
> Is it possible that you just tried to call `make run` instead of `make` 
> and `./step-42 p1_adaptive.prm`?
> Note that there are multiple parameter files:
> p1_adaptive.prm  
> p1_chinese.prm  
> p1_global.prm  
> p2_adaptive.prm  
> p2_global.prm
>
> 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] Re: Step-42

2017-05-15 Thread benhour . amirian66
Dear All,
Unfortunately I could not run this step. In fact, none of my friends also 
could run this step. I was wondering if you let me know it works in your 
system.

Thanks,
Benhour 

On Monday, May 15, 2017 at 6:25:51 AM UTC-5, Jean-Paul Pelteret wrote:
>
> Dear Benhour,
>
> I would suggest removing the CMakeCache.txt file and CMakeFiles directory 
> (both located in the tutorial/build directory). Then rerun CMake before 
> trying to build the tutorial. It might be that there are some stale 
> configuration settings that need to be updated.
>
> Regards,
> Jean-Paul
>
> On Monday, May 15, 2017 at 1:14:26 PM UTC+2, Daniel Arndt wrote:
>>
>> Ben,
>>
>> I tried with version 8.4.1 and also the new version, 8.5, however it does 
>>> not run at all. The errors that I got are given as below:
>>> make[3]: *** [CMakeFiles/run] Error 1
>>> make[2]: *** [CMakeFiles/run.dir/all] Error 2
>>> make[1]: *** [CMakeFiles/run.dir/rule] Error 2
>>> make: *** [run] Error 2
>>>
>> is this really all the output you get when calling "make"? This output 
>> alone does not really tell anything...
>>
>> 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] Re: Step-42

2017-05-15 Thread benhour . amirian66
Dear All,
Thanks very much for your help. I really appreciate your kindness if you 
let me know why this step cannot be run as other tutorials?

Bests,
Ben

On Monday, May 15, 2017 at 4:12:17 PM UTC-5, Bruno Turcksin wrote:
>
> Benhour,
>
> do the following three steps:
> cmake .
> make
> ./step-42 p1_adaptive.prm
>
> Best,
>
> Bruno
>
>
> On Monday, May 15, 2017 at 5:04:33 PM UTC-4, benhour@gmail.com 
>  wrote:
>>
>> Dear Jean-Paul,
>> If I did correct, first I call "cmake ." and then "make run ./step-42 
>> p1_adaptive.prm" and did not use "make". With these changes, it did not 
>> work again.
>>
>> Thanks,
>> Ben
>>
>> On Monday, May 15, 2017 at 3:27:29 PM UTC-5, Jean-Paul Pelteret wrote:
>>>
>>> Dear Benhour,
>>>
>>> I think that you must have misinterpreted what Daniel suggested. If I run
>>>
>>> ./step-42 p1_adaptive.prm

>>>
>>>  then this tutorial works fine for me. If I run "make run" then the 
>>> (unusual) error message appears for me as well. 
>>>
>>> Regards,
>>> Jean-Paul
>>>
>>> On Monday, May 15, 2017 at 7:30:25 PM UTC+2, benhour@gmail.com 
>>> wrote:

 Dear Daniel,
 According to your noteworthy comments, I tried exactly what you said, 
 however, I got exactly the same as before, as what you got.

 Thanks,
 Benhour

 On Monday, May 15, 2017 at 12:23:44 PM UTC-5, Daniel Arndt wrote:
>
> Benhour,
>
> `make run` gives me:
>
> Scanning dependencies of target step-42
> [ 33%] Building CXX object CMakeFiles/step-42.dir/step-42.cc.o
> [ 66%] Linking CXX executable step-42
> [ 66%] Built target step-42
> Scanning dependencies of target run
> [100%] Run step-42 with Debug configuration
> *** Call this program as <./step-42 input.prm>
> CMakeFiles/run.dir/build.make:57: recipe for target 'CMakeFiles/run' 
> failed
> make[3]: *** [CMakeFiles/run] Error 1
> CMakeFiles/Makefile2:259: recipe for target 'CMakeFiles/run.dir/all' 
> failed
> make[2]: *** [CMakeFiles/run.dir/all] Error 2
> CMakeFiles/Makefile2:266: recipe for target 'CMakeFiles/run.dir/rule' 
> failed
> make[1]: *** [CMakeFiles/run.dir/rule] Error 2
> Makefile:196: recipe for target 'run' failed
> make: *** [run] Error 2
>
> which is at least similar to what you are observing. The relevant line 
> here is:
> *** Call this program as <./step-42 input.prm>
>
> Is it possible that you just tried to call `make run` instead of 
> `make` and `./step-42 p1_adaptive.prm`?
> Note that there are multiple parameter files:
> p1_adaptive.prm  
> p1_chinese.prm  
> p1_global.prm  
> p2_adaptive.prm  
> p2_global.prm
>
> 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.