Changeset 16233


Ignore:
Timestamp:
09/23/13 11:01:34 (11 years ago)
Author:
Mathieu Morlighem
Message:

DEL: removed legacy code

Location:
issm/trunk-jpl/src/c
Files:
62 edited

Legend:

Unmodified
Added
Removed
  • TabularUnified issm/trunk-jpl/src/c/bamg/AdjacentTriangle.cpp

    r16232 r16233  
    1616        int  AdjacentTriangle::Locked() const {
    1717                return t->AdjEdgeIndex[a] & 4;
    18         }
    19         /*}}}*/
    20         /*FUNCTION AdjacentTriangle::MarkUnSwap {{{*/
    21         int  AdjacentTriangle::MarkUnSwap() const {
    22                 return t->AdjEdgeIndex[a] & 8;
    2318        }
    2419        /*}}}*/
  • TabularUnified issm/trunk-jpl/src/c/bamg/AdjacentTriangle.h

    r16232 r16233  
    3131                        //Methods
    3232                        int  Locked() const;
    33                         int  MarkUnSwap() const;
    3433                        int  GetAllFlag_UnSwap() const;
    3534                        void SetLock();
  • TabularUnified issm/trunk-jpl/src/c/bamg/BamgQuadtree.cpp

    r16158 r16233  
    391391        }
    392392        /*}}}*/
    393         /*FUNCTION BamgQuadtree::NearestVertexWithNormal{{{*/
    394         BamgVertex*  BamgQuadtree::NearestVertexWithNormal(Icoor1 i,Icoor1 j) {
    395                 /*Original code from Frederic Hecht <hecht@ann.jussieu.fr> (BAMG v1.01, BamgQuadtree.cpp/NearestVertexWithNormal)*/
    396 
    397                 BamgQuadtreeBox * pb[ MaxDepth ];
    398                 int  pi[ MaxDepth  ];
    399                 Icoor1 ii[  MaxDepth ], jj [ MaxDepth];
    400                 int l; // level
    401                 BamgQuadtreeBox * b;
    402                 long     h =MaxISize,h0;
    403                 long     hb=MaxISize;
    404                 Icoor1  i0=0,j0=0;
    405                 Icoor1  iplus( i<MaxISize?(i<0?0:i):MaxISize-1);
    406                 Icoor1  jplus( j<MaxISize?(j<0?0:j):MaxISize-1);
    407 
    408                 BamgVertex *vn=0;
    409 
    410                 // init for optimisation ---
    411                 b = root;
    412                 register long  n0;
    413                 if (!root->nbitems)
    414                  return vn; // empty tree
    415 
    416                 while( (n0 = b->nbitems) < 0)
    417                   {
    418                         // search the non empty
    419                         // BamgQuadtreeBox containing  the point (i,j)
    420                         register Icoor1 hb2 = hb >> 1 ;
    421                         register  int k = IJ(iplus,jplus,hb2);// BamgQuadtreeBox number of size hb2 contening i;j
    422                         register BamgQuadtreeBox * b0= b->b[k];
    423                         if ( ( b0 == 0) || (b0->nbitems == 0) )
    424                          break; // null box or empty   => break             
    425                         b=b0;   
    426                         i0 += I_IJ(k,hb2); // i orign of BamgQuadtreeBox
    427                         j0 += J_IJ(k,hb2); // j orign of BamgQuadtreeBox
    428                         hb = hb2;
    429                   }
    430 
    431                 if ( n0 > 0)
    432                   { 
    433                         for(register int k=0;k<n0;k++)
    434                           {
    435                                 I2 i2 =  b->v[k]->i;
    436                                 //   try if is in the right direction --
    437                                 h0 = NORM(iplus,i2.x,jplus,i2.y);
    438                                 if (h0 <h) {
    439                                         h = h0;
    440                                         vn = b->v[k];}
    441                           }
    442                         if (vn) return vn;
    443                   }
    444                 // general case -----
    445                 // INITIALISATION OF THE HEAP
    446                 l =0; // level
    447                 pb[0]= b;
    448                 pi[0]=b->nbitems>0 ?(int)  b->nbitems : 4  ;
    449                 ii[0]=i0;
    450                 jj[0]=j0;
    451                 h=hb;
    452                 do {   // walk on the tree 
    453                         b= pb[l];
    454                         while (pi[l]--) // loop on 4 element of the box
    455                           {           
    456                                 int k = pi[l];
    457 
    458                                 if (b->nbitems>0) // BamgVertex BamgQuadtreeBox none empty
    459                                   {
    460                                         I2 i2 =  b->v[k]->i;
    461                                         // if good direction when try --
    462 
    463                                         h0 = NORM(iplus,i2.x,jplus,i2.y);
    464                                         if (h0 <h)
    465                                           {
    466                                                 h = h0;
    467                                                 vn = b->v[k];
    468                                           }
    469                                   }
    470                                 else // Pointer BamgQuadtreeBox
    471                                   {
    472                                         register BamgQuadtreeBox *b0=b;
    473                                         if ((b=b->b[k]))
    474                                           {
    475                                                 hb >>=1 ; // div by 2
    476                                                 register Icoor1 iii = ii[l]+I_IJ(k,hb);
    477                                                 register Icoor1 jjj = jj[l]+J_IJ(k,hb);
    478 
    479                                                 if  (INTER_SEG(iii,iii+hb,iplus-h,iplus+h) && INTER_SEG(jjj,jjj+hb,jplus-h,jplus+h))
    480                                                   {
    481                                                         pb[++l]=  b;
    482                                                         pi[l]= b->nbitems>0 ?(int)  b->nbitems : 4  ;
    483                                                         ii[l]= iii;
    484                                                         jj[l]= jjj;
    485 
    486                                                   }
    487                                                 else
    488                                                  b=b0, hb <<=1 ;
    489                                           }
    490                                         else
    491                                          b=b0;
    492                                   }
    493                           }
    494                         hb <<= 1; // mul by 2
    495                 } while (l--);
    496 
    497                 return vn;
    498         }
    499         /*}}}*/
    500393        /*FUNCTION BamgQuadtree::NewBamgQuadtreeBox {{{*/
    501394        BamgQuadtree::BamgQuadtreeBox* BamgQuadtree::NewBamgQuadtreeBox(void){
  • TabularUnified issm/trunk-jpl/src/c/bamg/BamgQuadtree.h

    r15067 r16233  
    5252
    5353                        BamgVertex      *NearestVertex(Icoor1 i,Icoor1 j);
    54                         BamgVertex      *NearestVertexWithNormal(Icoor1  i,Icoor1 j);
    5554                        BamgQuadtreeBox *NewBamgQuadtreeBox(void);
    5655                        BamgVertex      *ToClose(BamgVertex &,double ,Icoor1,Icoor1);
  • TabularUnified issm/trunk-jpl/src/c/bamg/EigenMetric.cpp

    r15104 r16233  
    131131                return sqrt(1/bamg::Max(bamg::Min(lambda1,lambda2),1e-30));
    132132        }/*}}}*/
    133         /*FUNCTION EigenMetric::Isotrope{{{*/
    134         void   EigenMetric::Isotrope() {
    135                 lambda1=lambda2=bamg::Max(lambda1,lambda2);
    136         }/*}}}*/
    137133        /*FUNCTION EigenMetric::lmax{{{*/
    138134        double EigenMetric::lmax() const {
  • TabularUnified issm/trunk-jpl/src/c/bamg/ListofIntersectionTriangles.cpp

    r16158 r16233  
    178178                  }
    179179                return nbv-nbvold;
    180         }
    181         /*}}}*/
    182         /*FUNCTION ListofIntersectionTriangles::NewSubSeg{{{*/
    183         void  ListofIntersectionTriangles::NewSubSeg(GeomEdge *e,double s0,double s1){
    184                 long int verbosity=0;
    185                 if (NbSeg>=MaxNbSeg) {
    186                         int mneo= MaxNbSeg;
    187                         MaxNbSeg *= 2;
    188                         if (verbosity>3){
    189                                 _printf_("   reshape lSegsI from " << mneo << " to " << MaxNbSeg << "\n");
    190                         }
    191                         _assert_(lSegsI && NbSeg<MaxNbSeg);
    192                         SegInterpolation * lEn =  new SegInterpolation[MaxNbSeg];
    193                         for (int i=0;i< NbSeg;i++) lEn[i] = lSegsI[MaxNbSeg]; // copy old to new           
    194                         delete []  lSegsI; // remove old
    195                         lSegsI = lEn;       
    196                 }
    197                 if (NbSeg) lSegsI[NbSeg-1].last=Size;
    198                 lSegsI[NbSeg].e=e;
    199                 lSegsI[NbSeg].sBegin=s0;
    200                 lSegsI[NbSeg].sEnd=s1;     
    201                 NbSeg++;           
    202180        }
    203181        /*}}}*/
  • TabularUnified issm/trunk-jpl/src/c/bamg/ListofIntersectionTriangles.h

    r13036 r16233  
    6666                        double Length();
    6767                        long   NewPoints(BamgVertex *,long &nbv,long maxnbv);
    68                         void   NewSubSeg(GeomEdge *e,double s0,double s1);
    6968                        void   ReShape();
    7069        };
  • TabularUnified issm/trunk-jpl/src/c/bamg/Metric.h

    r15067 r16233  
    7272                        void   Minh(double h);
    7373                        void   Maxh(double h);
    74                         void   Isotrope();
    7574                        double hmin()   const;
    7675                        double hmax()   const;
  • TabularUnified issm/trunk-jpl/src/c/bamg/Triangle.cpp

    r16231 r16233  
    5353                return AdjacentTriangle(adj[i],AdjEdgeIndex[i]&3);
    5454        };/*}}}*/
    55         /*FUNCTION Triangle::Anisotropy{{{*/
    56         double Triangle::Anisotropy() const{
    57 
    58                 double lmin,lmax;
    59 
    60                 /*Get three vertices A,B and C*/
    61                 R2 A=*this->vertices[0];
    62                 R2 B=*this->vertices[1];
    63                 R2 C=*this->vertices[2];
    64 
    65                 /*Compute edges*/
    66                 R2 e1=B-A;
    67                 R2 e2=C-A;
    68                 R2 e3=B-C;
    69 
    70                 /*Compute edge length*/
    71                 double l1=Norme2(e1);
    72                 double l2=Norme2(e2);
    73                 double l3=Norme2(e3);
    74 
    75                 lmin=l1;
    76                 lmin=min(lmin,l2);
    77                 lmin=min(lmin,l3);
    78                 lmax=l1;
    79                 lmax=max(lmax,l2);
    80                 lmax=max(lmax,l3);
    81 
    82                 return lmax/lmin;
    83         };/*}}}*/
    8455        /*FUNCTION Triangle::Length{{{*/
    8556        double Triangle::Length() const{
     
    133104
    134105                return;
    135         }
    136         /*}}}*/
    137         /*FUNCTION Triangle::FindBoundaryEdge{{{*/
    138         AdjacentTriangle Triangle::FindBoundaryEdge(int i) const{
    139                 /*Original code from Frederic Hecht <hecht@ann.jussieu.fr> (BAMG v1.01, Mesh2.cpp/FindBoundaryEdge)*/
    140 
    141                 /*Intermediary*/
    142                 Triangle* ttc=NULL;
    143                 int k,j,jc;
    144 
    145                 // call current triangle t
    146                 Triangle* t = (Triangle*)this;
    147 
    148                 //is the current triangle inside or outside?
    149                 int outside=!link  ;
    150 
    151                 // EdgesVertexTriangle[3][2] = {{1,2},{2,0},{0,1}};
    152                 // initialize j as the first vertex of the ith edge
    153                 j=EdgesVertexTriangle[i][0];
    154 
    155                 //Loop over the adjacent triangle of t
    156                 k=0;
    157                 do{
    158                         //keep track of outside
    159                         int outsidep = outside;
    160                         //increment k
    161                         k++;
    162                         //Get ttc, adjacent triangle of t with respect to vertex j
    163                         ttc =  t->adj[j];
    164                         //is the current triangle inside or outside?
    165                         outside = !ttc->link;
    166                         //if both previous triangle are outside, return
    167                         if (outside+outsidep == 1) return AdjacentTriangle(t,j);
    168 
    169                         //update t and j
    170                         t = ttc;
    171                         //NextEdge[3] = {1,2,0};
    172                         jc = NextEdge[t->AdjEdgeIndex[j]&3];
    173                         j = NextEdge[jc];
    174 
    175                         //check number of iterations
    176                         if (k>=2000){
    177                                 _error_("too many iteration in Triangle::FindBoundaryEdge (k>=2000)");
    178                         }
    179                 } while (this!= t);
    180                 //not found, return empty triangle
    181                 return AdjacentTriangle(NULL,0);
    182106        }
    183107        /*}}}*/
  • TabularUnified issm/trunk-jpl/src/c/bamg/Triangle.h

    r16231 r16233  
    4040                        //Methods
    4141                        void              Echo();
    42                         double            Anisotropy() const;
    4342                        double            Length() const;
    4443                        int               swap(short a1,int=0);
     
    5049                        double            QualityQuad(int a,int option=1) const;
    5150                        short             NuEdgeTriangleAdj(int i) const;
    52                         AdjacentTriangle  FindBoundaryEdge(int  i) const;
    5351                        AdjacentTriangle  Adj(int i) const;
    5452                        Triangle         *TriangleAdj(int i) const;
  • TabularUnified issm/trunk-jpl/src/c/classes/Elements/Penta.cpp

    r16231 r16233  
    15311531                break;
    15321532        case StressbalanceVerticalAnalysisEnum:
    1533                 //GetSolutionFromInputsStressbalanceVert(solution);
    15341533                GetSolutionFromInputsOneDof(solution, VzEnum);
    15351534                break;
     
    15371536        #ifdef _HAVE_THERMAL_
    15381537        case ThermalAnalysisEnum:
    1539                 //GetSolutionFromInputsThermal(solution);
    15401538                GetSolutionFromInputsOneDof(solution, TemperatureEnum);
    15411539                break;
    15421540        case EnthalpyAnalysisEnum:
    1543                 //GetSolutionFromInputsEnthalpy(solution);
    15441541                GetSolutionFromInputsOneDof(solution, EnthalpyEnum);
    15451542                break;
     
    48514848        delete friction;
    48524849        return pe;
    4853 }
    4854 /*}}}*/
    4855 /*FUNCTION Penta::GetSolutionFromInputsThermal{{{*/
    4856 void  Penta::GetSolutionFromInputsThermal(Vector<IssmDouble>* solution){
    4857 
    4858         const int    numdof=NDOF1*NUMVERTICES;
    4859 
    4860         int         i;
    4861         int        *doflist = NULL;
    4862         IssmDouble  values[numdof];
    4863         IssmDouble  temp;
    4864         GaussPenta *gauss = NULL;
    4865 
    4866         /*Get dof list: */
    4867         GetDofList(&doflist,NoneApproximationEnum,GsetEnum);
    4868         Input* t_input=inputs->GetInput(TemperatureEnum); _assert_(t_input);
    4869 
    4870         gauss=new GaussPenta();
    4871         for(i=0;i<NUMVERTICES;i++){
    4872                 /*Recover temperature*/
    4873                 gauss->GaussVertex(i);
    4874                 t_input->GetInputValue(&temp,gauss);
    4875                 values[i]=temp;
    4876         }
    4877 
    4878         /*Add value to global vector*/
    4879         solution->SetValues(numdof,doflist,values,INS_VAL);
    4880 
    4881         /*Free ressources:*/
    4882         delete gauss;
    4883         xDelete<int>(doflist);
    4884 }
    4885 /*}}}*/
    4886 /*FUNCTION Penta::GetSolutionFromInputsEnthalpy{{{*/
    4887 void  Penta::GetSolutionFromInputsEnthalpy(Vector<IssmDouble>* solution){
    4888 
    4889         const int    numdof=NDOF1*NUMVERTICES;
    4890 
    4891         int*        doflist=NULL;
    4892         IssmDouble  values[numdof];
    4893         IssmDouble  enthalpy;
    4894         GaussPenta *gauss=NULL;
    4895 
    4896         /*Get dof list: */
    4897         GetDofList(&doflist,NoneApproximationEnum,GsetEnum);
    4898         Input* h_input=inputs->GetInput(EnthalpyEnum); _assert_(h_input);
    4899 
    4900         gauss=new GaussPenta();
    4901         for(int i=0;i<NUMVERTICES;i++){
    4902                 /*Recover temperature*/
    4903                 gauss->GaussVertex(i);
    4904                 h_input->GetInputValue(&enthalpy,gauss);
    4905                 values[i]=enthalpy;
    4906         }
    4907 
    4908         /*Add value to global vector*/
    4909         solution->SetValues(numdof,doflist,values,INS_VAL);
    4910 
    4911         /*Free ressources:*/
    4912         delete gauss;
    4913         xDelete<int>(doflist);
    49144850}
    49154851/*}}}*/
     
    98489784}
    98499785/*}}}*/
    9850 /*FUNCTION Penta::GetSolutionFromInputsStressbalanceVert{{{*/
    9851 void  Penta::GetSolutionFromInputsStressbalanceVert(Vector<IssmDouble>* solution){
    9852 
    9853         const int    numdof=NDOF1*NUMVERTICES;
    9854 
    9855         int          i;
    9856         int*         doflist=NULL;
    9857         IssmDouble       vz;
    9858         IssmDouble       values[numdof];
    9859         GaussPenta*  gauss=NULL;
    9860 
    9861         /*Get dof list: */
    9862         GetDofList(&doflist,NoneApproximationEnum,GsetEnum);
    9863         Input* vz_input=inputs->GetInput(VzEnum); _assert_(vz_input);
    9864 
    9865         /*Ok, we have vx and vy in values, fill in vx and vy arrays: */
    9866         /*P1 element only for now*/
    9867         gauss=new GaussPenta();
    9868         for(i=0;i<NUMVERTICES;i++){
    9869                 /*Recover vz */
    9870                 gauss->GaussVertex(i);
    9871                 vz_input->GetInputValue(&vz,gauss);
    9872                 values[i]=vz;
    9873         }
    9874 
    9875         /*Add value to global vector*/
    9876         solution->SetValues(numdof,doflist,values,INS_VAL);
    9877 
    9878         /*Free ressources:*/
    9879         delete gauss;
    9880         xDelete<int>(doflist);
    9881 }
    9882 /*}}}*/
    98839786/*FUNCTION Penta::GetSolutionFromInputsStressbalanceFS{{{*/
    98849787void  Penta::GetSolutionFromInputsStressbalanceFS(Vector<IssmDouble>* solution){
  • TabularUnified issm/trunk-jpl/src/c/classes/Elements/Penta.h

    r16231 r16233  
    203203                void             GetPhi(IssmDouble* phi, IssmDouble*  epsilon, IssmDouble viscosity);
    204204                void           GetQuadNormal(IssmDouble* normal,IssmDouble xyz_list[4][3]);
    205                 void             GetSolutionFromInputsEnthalpy(Vector<IssmDouble>* solutiong);
    206205                IssmDouble     GetStabilizationParameter(IssmDouble u, IssmDouble v, IssmDouble w, IssmDouble diameter, IssmDouble kappa);
    207206                void           GetStrainRate3dHO(IssmDouble* epsilon,IssmDouble* xyz_list, GaussPenta* gauss, Input* vx_input, Input* vy_input);
     
    278277                void             GetSolutionFromInputsStressbalanceSIA(Vector<IssmDouble>* solutiong);
    279278                void             GetSolutionFromInputsStressbalanceFS(Vector<IssmDouble>* solutiong);
    280                 void             GetSolutionFromInputsStressbalanceVert(Vector<IssmDouble>* solutiong);
    281279                ElementVector* CreatePVectorCouplingSSAFS(void);
    282280                ElementVector* CreatePVectorCouplingSSAFSViscous(void);
     
    348346                ElementVector* CreatePVectorThermalShelf(void);
    349347                ElementVector* CreatePVectorThermalSheet(void);
    350                 void             GetSolutionFromInputsThermal(Vector<IssmDouble>* solutiong);
    351348                void           InputUpdateFromSolutionThermal(IssmDouble* solutiong);
    352349                void           InputUpdateFromSolutionEnthalpy(IssmDouble* solutiong);
  • TabularUnified issm/trunk-jpl/src/c/classes/Elements/PentaRef.cpp

    r16158 r16233  
    18941894}
    18951895/*}}}*/
    1896 /*FUNCTION PentaRef::GetQuadNodalFunctions {{{*/
    1897 void PentaRef::GetQuadNodalFunctions(IssmDouble* l1l4,GaussPenta* gauss,int index1,int index2,int index3,int index4){
    1898         /*This routine returns the values of the nodal functions  at the gaussian point.*/
    1899 
    1900         IssmDouble BasisFunctions[6];
    1901 
    1902         GetNodalFunctionsP1(&BasisFunctions[0],gauss);
    1903 
    1904         _assert_(index1>=0 && index1<6);
    1905         _assert_(index2>=0 && index2<6);
    1906         _assert_(index3>=0 && index3<6);
    1907         _assert_(index4>=0 && index4<6);
    1908 
    1909         l1l4[0]=BasisFunctions[index1];
    1910         l1l4[1]=BasisFunctions[index2];
    1911         l1l4[2]=BasisFunctions[index3];
    1912         l1l4[3]=BasisFunctions[index4];
    1913 
    1914 }
    1915 /*}}}*/
    19161896/*FUNCTION PentaRef::GetQuadJacobianDeterminant{{{*/
    19171897void PentaRef::GetQuadJacobianDeterminant(IssmDouble* Jdet,IssmDouble xyz_list[4][3],GaussPenta* gauss){
  • TabularUnified issm/trunk-jpl/src/c/classes/Elements/PentaRef.h

    r15872 r16233  
    3535                void GetNodalFunctionsP1DerivativesReference(IssmDouble* dl1dl6,GaussPenta* gauss);
    3636                void GetNodalFunctionsMINIDerivativesReference(IssmDouble* dl1dl7,GaussPenta* gauss);
    37                 void GetQuadNodalFunctions(IssmDouble* l1l4,GaussPenta* gauss,int index1,int index2,int index3,int index4);
    3837                void GetQuadJacobianDeterminant(IssmDouble*  Jdet, IssmDouble xyz_list[4][3],GaussPenta* gauss);
    3938                void GetJacobian(IssmDouble* J, IssmDouble* xyz_list,GaussPenta* gauss);
  • TabularUnified issm/trunk-jpl/src/c/classes/Hook.cpp

    r15439 r16233  
    206206}
    207207/*}}}*/
    208 /*FUNCTION Hook::GetObjects{{{*/
    209 Object** Hook::GetObjects(void){
    210         return this->objects;
    211 }
    212 /*}}}*/
    213 /*FUNCTION Hook::GetOffsets{{{*/
    214 int* Hook::GetOffsets(void){
    215         return this->offsets;
    216 }
    217 /*}}}*/
    218208/*FUNCTION Hook::Spawn{{{*/
    219209Hook* Hook::Spawn(int* indices, int numindices){
  • TabularUnified issm/trunk-jpl/src/c/classes/Hook.h

    r15067 r16233  
    4040                void       configure(DataSet* dataset);
    4141                Hook*      Spawn(int* indices, int numindices);
    42                 Object**   GetObjects(void);
    4342                int*       Ids(void);
    44                 int*       GetOffsets(void);
    4543                int        GetNum(void);
    4644                /*}}}*/
  • TabularUnified issm/trunk-jpl/src/c/classes/Materials/Material.h

    r16146 r16233  
    3838                virtual IssmDouble GetBbar()=0;
    3939                virtual IssmDouble GetN()=0;
    40                 virtual IssmDouble GetZ()=0;
    4140                virtual IssmDouble GetD()=0;
    42                 virtual IssmDouble GetZbar()=0;
    4341                virtual IssmDouble GetDbar()=0;
    4442
  • TabularUnified issm/trunk-jpl/src/c/classes/Materials/Matice.cpp

    r16167 r16233  
    183183        inputs->GetInputAverage(&D,DamageDEnum);
    184184        return D;
    185 }
    186 /*}}}*/
    187 /*FUNCTION Matice::GetZ {{{*/
    188 IssmDouble Matice::GetZ(){
    189 
    190         /*Output*/
    191         IssmDouble D;
    192 
    193         inputs->GetInputAverage(&D,DamageDEnum);
    194         return 1/(1-D);
    195 }
    196 /*}}}*/
    197 /*FUNCTION Matice::GetZbar {{{*/
    198 IssmDouble Matice::GetZbar(){
    199 
    200         /*Output*/
    201         IssmDouble Dbar;
    202         inputs->GetInputAverage(&Dbar,DamageDbarEnum);
    203         return 1/(1-Dbar);
    204185}
    205186/*}}}*/
  • TabularUnified issm/trunk-jpl/src/c/classes/Materials/Matice.h

    r16167 r16233  
    6464                IssmDouble GetB();
    6565                IssmDouble GetBbar();
    66                 IssmDouble GetZ();
    6766                IssmDouble GetD();
    68                 IssmDouble GetZbar();
    6967                IssmDouble GetDbar();
    7068                IssmDouble GetN();
  • TabularUnified issm/trunk-jpl/src/c/classes/Materials/Matpar.h

    r16146 r16233  
    9696                IssmDouble GetN(){_error_("not supported");};
    9797                IssmDouble GetD(){_error_("not supported");};
    98                 IssmDouble GetZ(){_error_("not supported");};
    99                 IssmDouble GetZbar(){_error_("not supported");};
    10098                IssmDouble GetDbar(){_error_("not supported");};
    10199                /*}}}*/
  • TabularUnified issm/trunk-jpl/src/c/classes/Node.cpp

    r16228 r16233  
    401401        DofInFSet(dof-1);
    402402        this->indexing.svalues[dof-1]=0.;
    403 }
    404 /*}}}*/
    405 /*FUNCTION Node::CreateVecSets {{{*/
    406 void  Node::CreateVecSets(Vector<IssmDouble>* pv_g,Vector<IssmDouble>* pv_f,Vector<IssmDouble>* pv_s){
    407 
    408         IssmDouble gvalue=1.; //all nodes are in the g set;
    409         IssmDouble value;
    410 
    411         for(int i=0;i<this->indexing.gsize;i++){
    412 
    413                 /*g set: */
    414                 pv_g->SetValue(indexing.gdoflist[i],gvalue,INS_VAL);
    415 
    416                 /*f set: */
    417                 value=(IssmDouble)this->indexing.f_set[i];
    418                 pv_f->SetValue(indexing.gdoflist[i],value,INS_VAL);
    419 
    420                 /*s set: */
    421                 value=(IssmDouble)this->indexing.s_set[i];
    422                 pv_s->SetValue(indexing.gdoflist[i],value,INS_VAL);
    423 
    424         }
    425 
    426403}
    427404/*}}}*/
  • TabularUnified issm/trunk-jpl/src/c/classes/Node.h

    r16228 r16233  
    6868                void  DofInFSet(int dof);
    6969                int   GetDof(int dofindex,int setenum);
    70                 void  CreateVecSets(Vector<IssmDouble>* pv_g,Vector<IssmDouble>* pv_f,Vector<IssmDouble>* pv_s);
    7170                void  GetDofList(int* poutdoflist,int approximation_enum,int setenum);
    7271                void  GetLocalDofList(int* poutdoflist,int approximation_enum,int setenum);
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/BoolParam.cpp

    r15128 r16233  
    6565}
    6666/*}}}*/
    67 
    68 /*BoolParam virtual functions definitions: */
    69 /*FUNCTION BoolParam::GetParameterName{{{*/
    70 void BoolParam::GetParameterName(char**pname){
    71         EnumToStringx(pname,this->enum_type);
    72 }
    73 /*}}}*/
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/BoolParam.h

    r15128 r16233  
    6868                void  SetValue(FILE* fid){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold a FILE");}
    6969                void  SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold an array of matrices");}
    70 
    71                 void GetParameterName(char**pname);
    7270                /*}}}*/
    7371};
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/DataSetParam.cpp

    r15128 r16233  
    6868
    6969/*DataSetParam virtual functions definitions: */
    70 /*FUNCTION DataSetParam::GetParameterName{{{*/
    71 void DataSetParam::GetParameterName(char**pname){
    72         EnumToStringx(pname,this->enum_type);
    73 }
    74 /*}}}*/
    7570/*FUNCTION DataSetParam::GetParameterValue{{{*/
    7671void DataSetParam::GetParameterValue(DataSet** pdataset){
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/DataSetParam.h

    r15128 r16233  
    6969                void  SetValue(DataSet* dataset){_error_("DataSet param of enum " << enum_type << " (" << EnumToStringx(enum_type) << ") cannot hold a DataSet yet");}
    7070                void  SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array){_error_("DataSet param of enum " << enum_type << " (" << EnumToStringx(enum_type) << ") cannot hold an array of matrices");}
    71 
    72                 void GetParameterName(char**pname);
    73 
    7471                /*}}}*/
    7572};
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/DoubleMatArrayParam.cpp

    r15128 r16233  
    183183}
    184184/*}}}*/
    185 /*FUNCTION DoubleMatArrayParam::GetParameterName{{{*/
    186 void DoubleMatArrayParam::GetParameterName(char**pname){
    187         EnumToStringx(pname,this->enum_type);
    188 }
    189 /*}}}*/
    190185/*FUNCTION DoubleMatArrayParam::SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array){{{*/
    191186void  DoubleMatArrayParam::SetValue(IssmDouble** in_array, int in_M, int* in_mdim_array, int* in_ndim_array){
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/DoubleMatArrayParam.h

    r15128 r16233  
    7171                void  SetValue(FILE* fid){_error_("Bool param of enum " << enum_type << " (" << EnumToStringx(enum_type) << ") cannot hold a FILE");}
    7272                void  SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array);
    73 
    74                 void GetParameterName(char**pname);
    75 
    7673                /*}}}*/
    7774};
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/DoubleMatParam.cpp

    r16149 r16233  
    101101}
    102102/*}}}*/
    103 /*FUNCTION DoubleMatParam::GetParameterName{{{*/
    104 void DoubleMatParam::GetParameterName(char**pname){
    105         EnumToStringx(pname,this->enum_type);
    106 }
    107 /*}}}*/
    108103/*FUNCTION DoubleMatParam::SetValue{{{*/
    109104void  DoubleMatParam::SetValue(IssmDouble* IssmDoublearray,int in_M,int in_N){
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/DoubleMatParam.h

    r15128 r16233  
    7070                void  SetValue(FILE* fid){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold a FILE");}
    7171                void  SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold an array of matrices");}
    72 
    73                 void GetParameterName(char**pname);
    74 
    7572                /*}}}*/
    7673};
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/DoubleParam.cpp

    r15128 r16233  
    6464
    6565/*DoubleParam virtual functions definitions: */
    66 /*FUNCTION DoubleParam::GetParameterName{{{*/
    67 void DoubleParam::GetParameterName(char**pname){
    68         EnumToStringx(pname,this->enum_type);
    69 }
    70 /*}}}*/
    7166/*FUNCTION DoubleParam::GetParameterValue(int* pinteger){{{*/
    7267void DoubleParam::GetParameterValue(int* pinteger){
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/DoubleParam.h

    r15128 r16233  
    6969                void  SetValue(FILE* fid){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold a FILE");}
    7070                void  SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold an array of matrices");}
    71 
    72                 void GetParameterName(char**pname);
    73 
    7471                /*}}}*/
    7572};
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/DoubleVecParam.cpp

    r15128 r16233  
    116116}
    117117/*}}}*/
    118 /*FUNCTION DoubleVecParam::GetParameterName{{{*/
    119 void DoubleVecParam::GetParameterName(char**pname){
    120         EnumToStringx(pname,this->enum_type);
    121 }
    122 /*}}}*/
    123118/*FUNCTION DoubleVecParam::SetValue{{{*/
    124119void  DoubleVecParam::SetValue(IssmDouble* IssmDoublearray,int in_M){
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/DoubleVecParam.h

    r15128 r16233  
    6969                void  SetValue(FILE* fid){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold a FILE");}
    7070                void  SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold an array of matrices");}
    71 
    72                 void GetParameterName(char**pname);
    7371                /*}}}*/
    7472};
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/FileParam.cpp

    r15128 r16233  
    6565}
    6666/*}}}*/
    67 
    68 /*FileParam virtual functions definitions: */
    69 /*FUNCTION FileParam::GetParameterName{{{*/
    70 void FileParam::GetParameterName(char**pname){
    71         EnumToStringx(pname,this->enum_type);
    72 }
    73 /*}}}*/
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/FileParam.h

    r15128 r16233  
    6868                void  SetValue(FILE* fid){_error_("File param of enum " << enum_type << " (" << EnumToStringx(enum_type) << ") cannot hold a FILE");}
    6969                void  SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array){_error_("File param of enum " << enum_type << " (" << EnumToStringx(enum_type) << ") cannot hold an array of matrices");}
    70 
    71                 void GetParameterName(char**pname);
    72 
    7370                /*}}}*/
    7471};
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/GenericParam.h

    r15128 r16233  
    5555                /*Param vritual function definitions: {{{*/
    5656                int   InstanceEnum(){return myEnumVal;}
    57                 void GetParameterName(char**pname) {EnumToStringx(pname,this->myEnumVal);}
    58 
    5957                P& GetParameterValue() { return myP;}
    6058                const P& GetParameterValue()const { return myP;};
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/IntMatParam.cpp

    r16149 r16233  
    9696}
    9797/*}}}*/
    98 /*FUNCTION IntMatParam::GetParameterName{{{*/
    99 void IntMatParam::GetParameterName(char**pname){
    100         EnumToStringx(pname,this->enum_type);
    101 }
    102 /*}}}*/
    10398/*FUNCTION IntMatParam::SetValue{{{*/
    10499void  IntMatParam::SetValue(int* intarray,int in_M,int in_N){
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/IntMatParam.h

    r15128 r16233  
    7070                void  SetValue(FILE* fid){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold a FILE");}
    7171                void  SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold an array of matrices");}
    72 
    73                 void GetParameterName(char**pname);
    74 
    7572                /*}}}*/
    7673};
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/IntParam.cpp

    r15128 r16233  
    6565}
    6666/*}}}*/
    67 
    68 /*IntParam virtual functions definitions: */
    69 /*FUNCTION IntParam::GetParameterName{{{*/
    70 void IntParam::GetParameterName(char**pname){
    71         EnumToStringx(pname,this->enum_type);
    72 }
    73 /*}}}*/
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/IntParam.h

    r15128 r16233  
    6969                void  SetValue(FILE* fid){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold a FILE");}
    7070                void  SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold an array of matrices");}
    71 
    72                 void GetParameterName(char**pname);
    73 
    7471                /*}}}*/
    7572};
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/IntVecParam.cpp

    r15128 r16233  
    110110}
    111111/*}}}*/
    112 /*FUNCTION IntVecParam::GetParameterName{{{*/
    113 void IntVecParam::GetParameterName(char**pname){
    114         EnumToStringx(pname,this->enum_type);
    115 }
    116 /*}}}*/
    117112/*FUNCTION IntVecParam::SetValue{{{*/
    118113void  IntVecParam::SetValue(int* intarray,int in_M){
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/IntVecParam.h

    r15128 r16233  
    7070                void  SetValue(FILE* fid){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold a FILE");}
    7171                void  SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold an array of matrices");}
    72 
    73                 void GetParameterName(char**pname);
    7472                /*}}}*/
    7573};
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/MatrixParam.cpp

    r15128 r16233  
    8484}
    8585/*}}}*/
    86 /*FUNCTION MatrixParam::GetParameterName{{{*/
    87 void MatrixParam::GetParameterName(char**pname){
    88         EnumToStringx(pname,this->enum_type);
    89 }
    90 /*}}}*/
    9186/*FUNCTION MatrixParam::SetValue{{{*/
    9287void  MatrixParam::SetValue(Matrix<IssmDouble>* matrix){
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/MatrixParam.h

    r15128 r16233  
    6969                void  SetValue(FILE* fid){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold a FILE");}
    7070                void  SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold an array of matrices");}
    71 
    72                 void GetParameterName(char**pname);
    73 
    7471                /*}}}*/
    7572};
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/Param.h

    r15128 r16233  
    5555                virtual void  SetValue(FILE* fid)=0;
    5656                virtual void  SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array)=0;
    57                 virtual void  GetParameterName(char**pname)=0;
    5857};
    5958#endif
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/StringArrayParam.cpp

    r15128 r16233  
    128128}
    129129/*}}}*/
    130 /*FUNCTION StringArrayParam::GetParameterName{{{*/
    131 void StringArrayParam::GetParameterName(char**pname){
    132         EnumToStringx(pname,this->enum_type);
    133 }
    134 /*}}}*/
    135130/*FUNCTION StringArrayParam::SetValue{{{*/
    136131void  StringArrayParam::SetValue(char** stringarray,int M){
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/StringArrayParam.h

    r15128 r16233  
    7070                void  SetValue(FILE* fid){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold a FILE");}
    7171                void  SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold an array of matrices");}
    72 
    73                 void GetParameterName(char**pname);
    7472                /*}}}*/
    7573};
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/StringParam.cpp

    r15128 r16233  
    8383}
    8484/*}}}*/
    85 /*FUNCTION StringParam::GetParameterName{{{*/
    86 void StringParam::GetParameterName(char**pname){
    87         EnumToStringx(pname,this->enum_type);
    88 }
    89 /*}}}*/
    9085/*FUNCTION StringParam::SetValue{{{*/
    9186void  StringParam::SetValue(char* string){
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/StringParam.h

    r15128 r16233  
    6969                void  SetValue(FILE* fid){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold a FILE");}
    7070                void  SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold an array of matrices");}
    71 
    72                 void GetParameterName(char**pname);
    73 
    7471                /*}}}*/
    7572};
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/TransientParam.cpp

    r15128 r16233  
    127127}
    128128/*}}}*/
    129 /*FUNCTION TransientParam::GetParameterName{{{*/
    130 void TransientParam::GetParameterName(char**pname){
    131         EnumToStringx(pname,this->enum_type);
    132 }
    133 /*}}}*/
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/TransientParam.h

    r15128 r16233  
    7070                void  SetValue(FILE* fid){_error_("Parameter " <<EnumToStringx(enum_type) << " cannot hold a FILE");}
    7171                void  SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array){_error_("Parameter " <<EnumToStringx(enum_type) << " cannot hold an array of matrices");}
    72 
    73                 void GetParameterName(char**pname);
    74 
    7572                /*}}}*/
    7673};
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/VectorParam.cpp

    r15128 r16233  
    8787}
    8888/*}}}*/
    89 /*FUNCTION VectorParam::GetParameterName{{{*/
    90 void VectorParam::GetParameterName(char**pname){
    91         EnumToStringx(pname,this->enum_type);
    92 }
    93 /*}}}*/
    9489/*FUNCTION VectorParam::SetValue{{{*/
    9590void  VectorParam::SetValue(Vector<IssmDouble>* vector){
  • TabularUnified issm/trunk-jpl/src/c/classes/Params/VectorParam.h

    r15128 r16233  
    6969                void  SetValue(FILE* fid){_error_("Vector of enum " << enum_type << " (" << EnumToStringx(enum_type) << ") cannot hold a FILE");}
    7070                void  SetValue(IssmDouble** array, int M, int* mdim_array, int* ndim_array){_error_("Param "<< EnumToStringx(enum_type) << " cannot hold an array of matrices");}
    71 
    72                 void GetParameterName(char**pname);
    73 
    7471                /*}}}*/
    7572};
  • TabularUnified issm/trunk-jpl/src/c/classes/gauss/GaussPenta.cpp

    r16074 r16233  
    495495}
    496496/*}}}*/
    497 /*FUNCTION GaussPenta::GaussCenter{{{*/
    498 void GaussPenta::GaussCenter(void){
    499 
    500         /*update static arrays*/
    501         coord1=ONETHIRD;
    502         coord2=ONETHIRD;
    503         coord3=ONETHIRD;
    504         coord4=0.0;
    505 
    506 }
    507 /*}}}*/
    508497/*FUNCTION GaussPenta::GaussPoint{{{*/
    509498void GaussPenta::GaussPoint(int ig){
  • TabularUnified issm/trunk-jpl/src/c/classes/gauss/GaussPenta.h

    r16074 r16233  
    4747                void GaussNode(int finitelement,int iv);
    4848                void GaussFaceTria(int index1, int index2, int index3, int order);
    49                 void GaussCenter(void);
    5049                void SynchronizeGaussTria(GaussTria* gauss_tria);
    5150};
  • TabularUnified issm/trunk-jpl/src/c/classes/gauss/GaussTria.cpp

    r16200 r16233  
    341341}
    342342/*}}}*/
    343 /*FUNCTION GaussTria::GaussCenter{{{*/
    344 void GaussTria::GaussCenter(void){
    345 
    346         /*update static arrays*/
    347         coord1=ONETHIRD;
    348         coord2=ONETHIRD;
    349         coord3=ONETHIRD;
    350 
    351 }
    352 /*}}}*/
    353343/*FUNCTION GaussTria::GaussEdgeCenter{{{*/
    354344void GaussTria::GaussEdgeCenter(int index1,int index2){
  • TabularUnified issm/trunk-jpl/src/c/classes/gauss/GaussTria.h

    r16140 r16233  
    4242                void GaussVertex(int iv);
    4343                void GaussNode(int finitelement,int iv);
    44                 void GaussCenter(void);
    4544                void GaussEdgeCenter(int index1,int index2);
    4645};
  • TabularUnified issm/trunk-jpl/src/c/kml/KML_Object.cpp

    r15104 r16233  
    295295}
    296296/*}}}*/
    297 /*FUNCTION KML_Object::FindAttrib {{{*/
    298 void  KML_Object::FindAttrib(char** pvalue,char* name,char* deflt){
    299 
    300         int   i;
    301         KML_Attribute* katt=NULL;
    302 
    303 /*  loop over any attributes for the object  */
    304 
    305         if (attrib->Size())
    306                 for (i=0; i<attrib->Size(); i++)
    307                         if (!strcmp(((KML_Attribute *)attrib->GetObjectByOffset(i))->name,name)) {
    308                                 katt=(KML_Attribute *)attrib->GetObjectByOffset(i);
    309                                 break;
    310                         }
    311 
    312 /*  if found, get the value; otherwise use the default  */
    313 
    314         if (katt)
    315                 katt->Get(pvalue,deflt);
    316         else {
    317                 *pvalue=xNew<char>(strlen(deflt)+1);
    318                 memcpy(*pvalue,deflt,(strlen(deflt)+1)*sizeof(char));
    319         }
    320 
    321         return;
    322 }
    323 /*}}}*/
    324297/*FUNCTION KML_Object::WriteAttrib {{{*/
    325298void  KML_Object::WriteAttrib(FILE* filout,const char* indent){
     
    363336}
    364337/*}}}*/
    365 /*FUNCTION KML_Object::FindCommnt {{{*/
    366 void  KML_Object::FindCommnt(char** pvalue,int inum){
    367 
    368         KML_Comment* kcom=NULL;
    369 
    370 /*  loop over any comments for the object  */
    371 
    372         if (inum <= commnt->Size())
    373                 kcom=(KML_Comment *)commnt->GetObjectByOffset(inum-1);
    374 
    375 /*  if found, get the value; otherwise use the NULL  */
    376 
    377         if (kcom)
    378                 kcom->Get(pvalue);
    379 
    380         return;
    381 }
    382 /*}}}*/
    383338/*FUNCTION KML_Object::WriteCommnt {{{*/
    384339void  KML_Object::WriteCommnt(FILE* filout,const char* indent){
  • TabularUnified issm/trunk-jpl/src/c/kml/KML_Object.h

    r15068 r16233  
    3737                virtual void  WriteExp(FILE* fid,const char* nstr,int sgn,double cm,double sp);
    3838                virtual void  AddAttrib(const char* name,const char* value);
    39                 virtual void  FindAttrib(char** pvalue,char* name,char* deflt);
    4039                virtual void  WriteAttrib(FILE* fid,const char* indent);
    4140                virtual void  AddCommnt(int ncom,char** pcom);
    4241                virtual void  AddCommnt(char* value);
    43                 virtual void  FindCommnt(char** pvalue,int inum);
    4442                virtual void  WriteCommnt(FILE* fid,const char* indent);
    4543
  • TabularUnified issm/trunk-jpl/src/c/shared/Matrix/MatrixUtils.cpp

    r15688 r16233  
    367367
    368368}/*}}}*/
    369 /*FUNCTION MatrixTranspose(IssmDouble* Adet,IssmDouble* A) {{{*/
    370 void MatrixTranspose(IssmDouble* tA,IssmDouble* A, int nrows, int ncols){
    371         /*Transpose a n*m matrix*/
    372 
    373         int i,j;
    374 
    375         /*Check the the matrix has been allocated*/
    376         _assert_(tA);
    377 
    378         /*Transpose*/
    379         for(i=0;i<ncols;i++){
    380                 for(j=0;j<nrows;j++){
    381                         tA[i*nrows+j]=A[j*ncols+i];
    382                 }
    383         }
    384 
    385 }
    386 /*}}}*/
  • TabularUnified issm/trunk-jpl/src/c/shared/Matrix/matrix.h

    r14983 r16233  
    1515void Matrix3x3Invert(IssmDouble* Ainv, IssmDouble* A);
    1616void Matrix3x3Determinant(IssmDouble* Adet,IssmDouble* A);
    17 void MatrixTranspose(IssmDouble* tA,IssmDouble* A,int nrows, int ncols);
    1817
    1918#endif //ifndef _MATRIXUTILS_H_
Note: See TracChangeset for help on using the changeset viewer.