- The deprecated constructor of SparseILU.
- SparseILU::apply_decomposition.
- The deprecated constructor of SparseMIC.
+- The compress() functions without argument in the various vector
+ classes. You should use the versions with a VectorOperation
+ argument instead.
<!-- ----------- GENERAL IMPROVEMENTS ----------------- -->
*/
void compress (::dealii::VectorOperation::values operation);
- /**
- * @deprecated: use compress(VectorOperation::values) instead.
- */
- void compress () DEAL_II_DEPRECATED;
-
/**
* Access to a single block.
*/
-template <class VectorType>
-inline
-void
-BlockVectorBase<VectorType>::compress ()
-{
- compress(VectorOperation::unknown);
-}
-
-
-
template <class VectorType>
inline
typename BlockVectorBase<VectorType>::iterator
*/
void compress (::dealii::VectorOperation::values operation);
- /**
- * @deprecated: use compress(VectorOperation::values) instead.
- */
- void compress () DEAL_II_DEPRECATED;
-
/**
* Fills the data field for ghost indices with the values stored in the
* respective positions of the owning processor. This function is needed
- template <typename Number>
- inline
- void
- Vector<Number>::compress ()
- {
- compress(VectorOperation::unknown);
- }
-
-
-
template <typename Number>
inline
void
*/
void compress (::dealii::VectorOperation::values operation);
- /**
- * @deprecated: use compress(VectorOperation::values) instead.
- */
- void compress () DEAL_II_DEPRECATED;
-
/**
* Set all components of the vector to the given number @p s. Simply pass
* this down to the individual block objects, but we still need to declare
// ---------------------------------------------------------------------
//
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
*/
void compress (::dealii::VectorOperation::values operation);
- /**
- * @deprecated: Use the compress(VectorOperation::values) function above
- * instead.
- */
- void compress() DEAL_II_DEPRECATED;
-
/**
* @deprecated Use compress(dealii::VectorOperation::values) instead.
*/
- inline
- void
- VectorBase::compress ()
- {
- compress(VectorOperation::unknown);
- }
-
-
-
inline
VectorBase &
VectorBase::operator = (const TrilinosScalar s)
- void
- VectorBase::compress ()
- {
- compress(VectorOperation::unknown);
- }
-
-
-
VectorBase::real_type
VectorBase::norm_sqr () const
{
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
VEC x(3);
x(0)=10;
deallog << x.l2_norm() << std::endl;
- x.compress();
+ x.compress(VectorOperation::insert);
deallog << "OK" << std::endl;
}
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int i=0; i<v.size(); i+=1+i)
v(i) = i;
- v.compress ();
+ v.compress (VectorOperation::insert);
Assert (v.size() == 100, ExcInternalError());
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
pattern[i] = true;
}
- v.compress ();
+ v.compress (VectorOperation::insert);
// check that they are ok, and this time
// all of them
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
pattern[i] = true;
}
- v.compress ();
+ v.compress (VectorOperation::add);
// check that they are ok, and this time
// all of them
v(i) = i;
pattern[i] = true;
}
+ v.compress (VectorOperation::insert);
for (unsigned int i=0; i<v.size(); i+=1+i)
v(i) += i;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
v(i) = i;
norm += std::fabs(1.*i);
}
- v.compress ();
+ v.compress (VectorOperation::insert);
// then check the norm
Assert (v.l1_norm() == norm, ExcInternalError());
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
v(i) = i;
norm += std::fabs(1.*i)*std::fabs(1.*i);
}
- v.compress ();
+ v.compress (VectorOperation::insert);
// then check the norm
const double eps=typeid(TrilinosScalar)==typeid(double) ? 1e-14 : 1e-5;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
v(i) = i;
norm = std::max(norm,fabs(i));
}
- v.compress ();
+ v.compress (VectorOperation::insert);
// then check the norm
Assert (v.linfty_norm() == norm, ExcInternalError());
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
v(i) = i;
pattern[i] = true;
}
- v.compress ();
+ v.compress (VectorOperation::insert);
// multiply v with 5/4
v *= 5./4.;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
v(i) = i;
pattern[i] = true;
}
- v.compress ();
+ v.compress (VectorOperation::insert);
// multiply v with 3/4
v /= 4./3.;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
v(i) = i;
else
w(i) = i;
- v.compress ();
- w.compress ();
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
// make sure the scalar product is zero
Assert (v*w == 0, ExcInternalError());
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
}
}
- v.compress ();
- w.compress ();
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
// make sure the scalar product is zero
Assert (v*w == product, ExcInternalError());
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int i=0; i<v.size(); ++i)
if (i%3 == 0)
v(i) = i+1.;
- v.compress ();
+ v.compress (VectorOperation::insert);
// then clear it again and make sure the
// vector is really empty
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int i=0; i<v.size(); ++i)
if (i%3 == 0)
v(i) = i+1.;
- v.compress ();
+ v.compress (VectorOperation::insert);
// then clear it again and make sure the
// vector is really empty
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int i=0; i<v.size(); ++i)
if (i%3 == 0)
v(i) = i+1.;
- v.compress ();
+ v.compress (VectorOperation::insert);
const unsigned int sz = v.size();
v = 2;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int i=0; i<v.size(); ++i)
if (i%3 == 0)
v(i) = i+1.;
- v.compress ();
+ v.compress (VectorOperation::insert);
// then copy it
TrilinosWrappers::Vector w (v.size());
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int i=0; i<v.size(); ++i)
if (i%3 == 0)
v(i) = i+1.;
- v.compress ();
+ v.compress (VectorOperation::insert);
// then copy it to a vector of different
// size
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int i=0; i<v.size(); ++i)
if (i%3 == 0)
v(i) = i+1.;
- v.compress ();
+ v.compress (VectorOperation::insert);
// then resize with setting to zero
v.reinit (13);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
v(i) = i;
norm += std::fabs(1.*i)*std::fabs(1.*i);
}
- v.compress ();
+ v.compress (VectorOperation::insert);
// then check the norm
const double eps=typeid(TrilinosScalar)==typeid(double) ? 1e-14 : 1e-5;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
v(i) = i;
sum += i;
}
- v.compress ();
+ v.compress (VectorOperation::insert);
// then check the norm
const double eps=typeid(TrilinosScalar)==typeid(double) ? 1e-14 : 1e-5;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
v(i) = i;
sum += i*i*i;
}
- v.compress ();
+ v.compress (VectorOperation::insert);
// then check the norm
const double eps=typeid(TrilinosScalar)==typeid(double) ? 1e-14 : 1e-5;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
v(i) = i;
sum += i*i*i;
}
- v.compress ();
+ v.compress (VectorOperation::insert);
// set them to zero again
v = 0;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
w(i) = i+1.;
}
- v.compress ();
- w.compress ();
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
v += w;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
w(i) = i+1.;
}
- v.compress ();
- w.compress ();
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
v -= w;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int i=0; i<v.size(); ++i)
v(i) = i;
- v.compress ();
+ v.compress (VectorOperation::insert);
v.add (1.);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
w(i) = i+1.;
}
- v.compress ();
- w.compress ();
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
v.add (w);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
w(i) = i+1.;
}
- v.compress ();
- w.compress ();
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
v.add (2, w);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
x(i) = i+2.;
}
- v.compress ();
- w.compress ();
- x.compress ();
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
+ x.compress (VectorOperation::insert);
v.add (2, w, 3, x);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
w(i) = i+1.;
}
- v.compress ();
- w.compress ();
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
v.sadd (2, w);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
w(i) = i+1.;
}
- v.compress ();
- w.compress ();
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
v.sadd (3, 2, w);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
x(i) = i+2.;
}
- v.compress ();
- w.compress ();
- x.compress ();
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
+ x.compress (VectorOperation::insert);
v.sadd (1.5, 2, w, 3, x);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
y(i) = i+3.;
}
- v.compress ();
- w.compress ();
- x.compress ();
- y.compress ();
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
+ x.compress (VectorOperation::insert);
+ y.compress (VectorOperation::insert);
v.sadd (1.5, 2, w, 3, x, 4, y);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
w(i) = i+1.;
}
- v.compress ();
- w.compress ();
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
v.scale (w);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
w(i) = i+1.;
}
- v.compress ();
- w.compress ();
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
v.equ (2, w);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
x(i) = i+2.;
}
- v.compress ();
- w.compress ();
- x.compress ();
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
+ x.compress (VectorOperation::insert);
v.equ (2, w, 3, x);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
x(i) = i+2.;
}
- v.compress ();
- w.compress ();
- x.compress ();
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
+ x.compress (VectorOperation::insert);
v.ratio (w, x);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int i=0; i<v.size(); ++i)
if (i%3 == 0)
v(i) = i+1.;
- v.compress ();
+ v.compress (VectorOperation::insert);
// then copy it
TrilinosWrappers::Vector w (v);
- w.compress ();
+ w.compress (VectorOperation::insert);
// make sure they're equal
deallog << v *w << ' ' << v.l2_norm() * w.l2_norm()
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
v(i) = i;
pattern[i] = true;
}
+ v.compress (VectorOperation::insert);
for (unsigned int i=0; i<v.size(); i+=1+i)
v(i) += i;
- v.compress ();
+ v.compress (VectorOperation::add);
// check that they are ok, and this time
// all of them
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
v(i) = 2*i;
pattern[i] = true;
}
+ v.compress (VectorOperation::insert);
for (unsigned int i=0; i<v.size(); i+=1+i)
v(i) -= i;
- v.compress ();
+ v.compress (VectorOperation::add);
// check that they are ok, and this time
// all of them
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int i=0; i<v.size(); i+=1+i)
v(i) *= 2;
- v.compress ();
+ v.compress (VectorOperation::insert);
// check that they are ok, and this time
// all of them
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int i=0; i<v.size(); i+=1+i)
v(i) /= 2;
- v.compress ();
+ v.compress (VectorOperation::insert);
// check that they are ok, and this time
// all of them
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
pattern[i] = true;
}
- v.compress ();
+ v.compress (VectorOperation::add);
// check that the vector is really
// non-negative
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
pattern[i] = true;
}
- v.compress ();
+ v.compress (VectorOperation::add);
Vector<double> w (v);
Vector<float> x (v);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
pattern[i] = true;
}
- v.compress ();
+ v.compress (VectorOperation::add);
Vector<double> w (v);
Vector<float> x (v);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
pattern[i] = true;
}
- v.compress ();
+ v.compress (VectorOperation::add);
Vector<double> w;
w=v;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
pattern[i] = true;
}
- v.compress ();
+ v.compress (VectorOperation::add);
Vector<double> w(v.size());
w=v;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
TrilinosWrappers::Vector u(dim);
f = 1.;
A.compress ();
- f.compress ();
- u.compress ();
+ f.compress (VectorOperation::insert);
+ u.compress (VectorOperation::insert);
GrowingVectorMemory<TrilinosWrappers::Vector> mem;
SolverCG<TrilinosWrappers::Vector> solver(control, mem);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
TrilinosWrappers::Vector u(dim);
f = 1.;
A.compress ();
- f.compress ();
- u.compress ();
+ f.compress (VectorOperation::insert);
+ u.compress (VectorOperation::insert);
GrowingVectorMemory<TrilinosWrappers::Vector> mem;
SolverBicgstab<TrilinosWrappers::Vector> solver(control,mem);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
TrilinosWrappers::Vector u(dim);
f = 1.;
A.compress ();
- f.compress ();
- u.compress ();
+ f.compress (VectorOperation::insert);
+ u.compress (VectorOperation::insert);
GrowingVectorMemory<TrilinosWrappers::Vector> mem;
SolverGMRES<TrilinosWrappers::Vector> solver(control,mem);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
TrilinosWrappers::Vector u(dim);
f = 1.;
A.compress ();
- f.compress ();
- u.compress ();
+ f.compress (VectorOperation::insert);
+ u.compress (VectorOperation::insert);
GrowingVectorMemory<TrilinosWrappers::Vector> mem;
SolverMinRes<TrilinosWrappers::Vector> solver(control,mem);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
TrilinosWrappers::Vector u(dim);
f = 1.;
A.compress ();
- f.compress ();
- u.compress ();
+ f.compress (VectorOperation::insert);
+ u.compress (VectorOperation::insert);
GrowingVectorMemory<TrilinosWrappers::Vector> mem;
SolverQMRS<TrilinosWrappers::Vector> solver(control,mem);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
TrilinosWrappers::Vector u(dim);
f = 1.;
A.compress ();
- f.compress ();
- u.compress ();
+ f.compress (VectorOperation::insert);
+ u.compress (VectorOperation::insert);
GrowingVectorMemory<TrilinosWrappers::Vector> mem;
SolverRichardson<TrilinosWrappers::Vector> solver(control,mem,0.1);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
TrilinosWrappers::Vector u(dim);
f = 1.;
A.compress ();
- f.compress ();
- u.compress ();
+ f.compress (VectorOperation::insert);
+ u.compress (VectorOperation::insert);
TrilinosWrappers::SolverCG solver(control);
TrilinosWrappers::PreconditionJacobi preconditioner;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
TrilinosWrappers::Vector u(dim);
f = 1.;
A.compress ();
- f.compress ();
- u.compress ();
+ f.compress (VectorOperation::insert);
+ u.compress (VectorOperation::insert);
TrilinosWrappers::SolverGMRES solver(control);
TrilinosWrappers::PreconditionJacobi preconditioner;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
TrilinosWrappers::Vector u(dim);
f = 1.;
A.compress ();
- f.compress ();
- u.compress ();
+ f.compress (VectorOperation::insert);
+ u.compress (VectorOperation::insert);
TrilinosWrappers::SolverCGS solver(control);
TrilinosWrappers::PreconditionJacobi preconditioner;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int i=0; i<v.size(); ++i)
v(i) = i;
- m.compress ();
- v.compress ();
- w.compress ();
+ m.compress (VectorOperation::insert);
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
// w:=Mv
m.vmult (w,v);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int i=0; i<v.size(); ++i)
v(i) = i;
- m.compress ();
- v.compress ();
- w.compress ();
+ m.compress (VectorOperation::insert);
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
// w:=Mv
m.Tvmult (w,v);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
w(i) = i;
}
- m.compress ();
- v.compress ();
- w.compress ();
+ m.compress (VectorOperation::insert);
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
// w:=Mv
m.vmult_add (w,v);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
w(i) = i;
}
- m.compress ();
- v.compress ();
- w.compress ();
+ m.compress (VectorOperation::insert);
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
// w:=Mv
m.Tvmult_add (w,v);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
w(i) = i+1;
}
- m.compress ();
- v.compress ();
- w.compress ();
+ m.compress (VectorOperation::insert);
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
// <w,Mv>
const TrilinosScalar s = m.matrix_scalar_product (w,v);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int i=0; i<v.size(); ++i)
v(i) = i;
- m.compress ();
- v.compress ();
+ m.compress (VectorOperation::insert);
+ v.compress (VectorOperation::insert);
// <w,Mv>
const TrilinosScalar s = m.matrix_norm_square (v);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
w(i) = i+1;
}
- m.compress ();
- v.compress ();
- w.compress ();
+ m.compress (VectorOperation::insert);
+ v.compress (VectorOperation::insert);
+ w.compress (VectorOperation::insert);
// x=w-Mv
const double s = m.residual (x, v, w);