Changeset 9451


Ignore:
Timestamp:
08/26/11 10:36:18 (14 years ago)
Author:
Mathieu Morlighem
Message:

removed all other model fields to be deleted

Location:
issm/trunk/src
Files:
1 deleted
39 edited

Legend:

Unmodified
Added
Removed
  • issm/trunk/src/c/EnumDefinitions/EnumDefinitions.h

    r9405 r9451  
    194194        DragPEnum,
    195195        DragQEnum,
    196         DragTypeEnum,
     196        Fake41Enum,
    197197        DtEnum,
    198198        TimeAdaptEnum,
     
    342342        Fake9Enum,
    343343        BasalMeltingRateCorrectionEnum,
    344         BasalMeltingRateCorrectionApplyEnum,
    345344        MixedLayerCapacityEnum,
    346345        ThermalExchangeVelocityEnum,
     
    395394        Fake20Enum,
    396395        Fake21Enum,
    397         PenaltyMeltingEnum,
     396        Fake42Enum,
    398397        QmuAnalysisEnum,
    399398        QmuErrNameEnum,
     
    404403        QmuPartEnum,
    405404        QmuNumberOfResponsesEnum,
    406         QmuSaveFemmodelEnum,
     405        Fake43Enum,
    407406        IndexedEnum,
    408407        RegularEnum,
     
    412411        ResponsedescriptorsEnum,
    413412        PetscRcEnum,
    414         SparsityEnum,
     413        Fake40Enum,
    415414        Fake22Enum,
    416415        VariabledescriptorsEnum,
  • issm/trunk/src/c/modules/EnumToStringx/EnumToStringx.cpp

    r9405 r9451  
    162162                case DragPEnum : return "DragP";
    163163                case DragQEnum : return "DragQ";
    164                 case DragTypeEnum : return "DragType";
     164                case Fake41Enum : return "Fake41";
    165165                case DtEnum : return "Dt";
    166166                case TimeAdaptEnum : return "TimeAdapt";
     
    296296                case Fake9Enum : return "Fake9";
    297297                case BasalMeltingRateCorrectionEnum : return "BasalMeltingRateCorrection";
    298                 case BasalMeltingRateCorrectionApplyEnum : return "BasalMeltingRateCorrectionApply";
    299298                case MixedLayerCapacityEnum : return "MixedLayerCapacity";
    300299                case ThermalExchangeVelocityEnum : return "ThermalExchangeVelocity";
     
    345344                case Fake20Enum : return "Fake20";
    346345                case Fake21Enum : return "Fake21";
    347                 case PenaltyMeltingEnum : return "PenaltyMelting";
     346                case Fake42Enum : return "Fake42";
    348347                case QmuAnalysisEnum : return "QmuAnalysis";
    349348                case QmuErrNameEnum : return "QmuErrName";
     
    354353                case QmuPartEnum : return "QmuPart";
    355354                case QmuNumberOfResponsesEnum : return "QmuNumberOfResponses";
    356                 case QmuSaveFemmodelEnum : return "QmuSaveFemmodel";
     355                case Fake43Enum : return "Fake43";
    357356                case IndexedEnum : return "Indexed";
    358357                case RegularEnum : return "Regular";
     
    362361                case ResponsedescriptorsEnum : return "Responsedescriptors";
    363362                case PetscRcEnum : return "PetscRc";
    364                 case SparsityEnum : return "Sparsity";
     363                case Fake40Enum : return "Fake40";
    365364                case Fake22Enum : return "Fake22";
    366365                case VariabledescriptorsEnum : return "Variabledescriptors";
  • issm/trunk/src/c/modules/ModelProcessorx/DiagnosticHoriz/UpdateElementsDiagnosticHoriz.cpp

    r9405 r9451  
    5555        iomodel->FetchDataToInput(elements,DragPEnum);
    5656        iomodel->FetchDataToInput(elements,DragQEnum);
    57         iomodel->FetchDataToInput(elements,DragTypeEnum);
    5857        iomodel->FetchDataToInput(elements,ElementOnIceShelfEnum);
    5958        iomodel->FetchDataToInput(elements,ElementOnWaterEnum);
  • issm/trunk/src/c/modules/ModelProcessorx/Thermal/UpdateElementsThermal.cpp

    r9405 r9451  
    4747        iomodel->FetchDataToInput(elements,DragPEnum);
    4848        iomodel->FetchDataToInput(elements,DragQEnum);
    49         iomodel->FetchDataToInput(elements,DragTypeEnum);
    5049        iomodel->FetchDataToInput(elements,ElementOnIceShelfEnum);
    5150        iomodel->FetchDataToInput(elements,ElementOnBedEnum);
  • issm/trunk/src/c/modules/StringToEnumx/StringToEnumx.cpp

    r9405 r9451  
    160160        else if (strcmp(name,"DragP")==0) return DragPEnum;
    161161        else if (strcmp(name,"DragQ")==0) return DragQEnum;
    162         else if (strcmp(name,"DragType")==0) return DragTypeEnum;
     162        else if (strcmp(name,"Fake41")==0) return Fake41Enum;
    163163        else if (strcmp(name,"Dt")==0) return DtEnum;
    164164        else if (strcmp(name,"TimeAdapt")==0) return TimeAdaptEnum;
     
    294294        else if (strcmp(name,"Fake9")==0) return Fake9Enum;
    295295        else if (strcmp(name,"BasalMeltingRateCorrection")==0) return BasalMeltingRateCorrectionEnum;
    296         else if (strcmp(name,"BasalMeltingRateCorrectionApply")==0) return BasalMeltingRateCorrectionApplyEnum;
    297296        else if (strcmp(name,"MixedLayerCapacity")==0) return MixedLayerCapacityEnum;
    298297        else if (strcmp(name,"ThermalExchangeVelocity")==0) return ThermalExchangeVelocityEnum;
     
    343342        else if (strcmp(name,"Fake20")==0) return Fake20Enum;
    344343        else if (strcmp(name,"Fake21")==0) return Fake21Enum;
    345         else if (strcmp(name,"PenaltyMelting")==0) return PenaltyMeltingEnum;
     344        else if (strcmp(name,"Fake42")==0) return Fake42Enum;
    346345        else if (strcmp(name,"QmuAnalysis")==0) return QmuAnalysisEnum;
    347346        else if (strcmp(name,"QmuErrName")==0) return QmuErrNameEnum;
     
    352351        else if (strcmp(name,"QmuPart")==0) return QmuPartEnum;
    353352        else if (strcmp(name,"QmuNumberOfResponses")==0) return QmuNumberOfResponsesEnum;
    354         else if (strcmp(name,"QmuSaveFemmodel")==0) return QmuSaveFemmodelEnum;
     353        else if (strcmp(name,"Fake43")==0) return Fake43Enum;
    355354        else if (strcmp(name,"Indexed")==0) return IndexedEnum;
    356355        else if (strcmp(name,"Regular")==0) return RegularEnum;
     
    360359        else if (strcmp(name,"Responsedescriptors")==0) return ResponsedescriptorsEnum;
    361360        else if (strcmp(name,"PetscRc")==0) return PetscRcEnum;
    362         else if (strcmp(name,"Sparsity")==0) return SparsityEnum;
     361        else if (strcmp(name,"Fake40")==0) return Fake40Enum;
    363362        else if (strcmp(name,"Fake22")==0) return Fake22Enum;
    364363        else if (strcmp(name,"Variabledescriptors")==0) return VariabledescriptorsEnum;
  • issm/trunk/src/c/objects/Elements/Penta.cpp

    r9405 r9451  
    350350
    351351        /*Intermediaries */
    352         int        count,ig;
    353         int        drag_type;
    354         double     basalfriction[NUMVERTICES]={0,0,0,0,0,0};
     352        int    count,ig;
     353        double basalfriction[NUMVERTICES]={0,0,0,0,0,0};
    355354        double alpha2,vx,vy;
    356355        Friction*  friction=NULL;
     
    372371
    373372        /*Build friction element, needed later: */
    374         inputs->GetParameterValue(&drag_type,DragTypeEnum);
    375         if (drag_type!=2)_error_(" non-viscous friction not supported yet!");
    376373        friction=new Friction("3d",inputs,matpar,DiagnosticHorizAnalysisEnum);
    377374
     
    812809       
    813810        /*Intermediaries */
    814         int       i,j,ig,analysis_type,drag_type;
     811        int       i,j,ig,analysis_type;
    815812        double    Jdet2d,slope_magnitude,alpha2;
    816813        double    xyz_list[NUMVERTICES][3];
     
    838835        for(i=0;i<NUMVERTICES2D;i++) for(j=0;j<2;j++) xyz_list_tria[i][j]=xyz_list[i][j];
    839836        parameters->FindParam(&analysis_type,AnalysisTypeEnum);
    840         inputs->GetParameterValue(&drag_type,DragTypeEnum);
    841837        Input* surface_input=inputs->GetInput(SurfaceEnum); _assert_(surface_input);
    842838        Input* vx_input=inputs->GetInput(VxEnum);           _assert_(vx_input);
     
    845841
    846842        /*build friction object, used later on: */
    847         if (drag_type!=2)_error_(" non-viscous friction not supported yet!");
    848843        friction=new Friction("2d",inputs,matpar,analysis_type);
    849844
     
    14761471        /*Intermediaries */
    14771472        int       i,j,ig;
    1478         int       analysis_type,drag_type;
     1473        int       analysis_type;
    14791474        double    xyz_list[NUMVERTICES][3];
    14801475        double    xyz_list_tria[NUMVERTICES2D][3]={0.0};
     
    14981493        for(i=0;i<NUMVERTICES2D;i++) for(j=0;j<2;j++) xyz_list_tria[i][j]=xyz_list[i][j];
    14991494        parameters->FindParam(&analysis_type,AnalysisTypeEnum);
    1500         inputs->GetParameterValue(&drag_type,DragTypeEnum);
    15011495        Input* surface_input=inputs->GetInput(SurfaceEnum); _assert_(surface_input);
    15021496        Input* vx_input=inputs->GetInput(VxEnum);           _assert_(vx_input);
     
    15051499
    15061500        /*build friction object, used later on: */
    1507         if (drag_type!=2)_error_(" non-viscous friction not supported yet!");
    15081501        friction=new Friction("2d",inputs,matpar,analysis_type);
    15091502
     
    34373430        /*Intermediaries */
    34383431        int        i,j,ig;
    3439         int        analysis_type,drag_type;
     3432        int        analysis_type;
    34403433        double     xyz_list[NUMVERTICES][3];
    34413434        double     xyz_list_tria[NUMVERTICES2D][3]={0.0};
     
    34673460
    34683461        /*Build frictoin element, needed later: */
    3469         inputs->GetParameterValue(&drag_type,DragTypeEnum);
    3470         if (drag_type!=2)_error_(" non-viscous friction not supported yet!");
    34713462        friction=new Friction("3d",inputs,matpar,analysis_type);
    34723463
     
    37063697        /*Intermediaries */
    37073698        int        i,j,ig;
    3708         int        analysis_type,drag_type;
     3699        int        analysis_type;
    37093700        double     xyz_list[NUMVERTICES][3];
    37103701        double     xyz_list_tria[NUMVERTICES2D][3]={0.0};
     
    37363727
    37373728        /*Build frictoin element, needed later: */
    3738         inputs->GetParameterValue(&drag_type,DragTypeEnum);
    3739         if (drag_type!=2)_error_(" non-viscous friction not supported yet!");
    37403729        friction=new Friction("3d",inputs,matpar,analysis_type);
    37413730
     
    45144503
    45154504        int        i,j,ig;
    4516         int        drag_type,analysis_type;
     4505        int        analysis_type;
    45174506        int        doflist1[NUMVERTICES];
    45184507        double     vx,vy,lambda,mu,alpha_complement,Jdet;
     
    45424531
    45434532        /*Build frictoin element, needed later: */
    4544         inputs->GetParameterValue(&drag_type,DragTypeEnum);
    45454533        friction=new Friction("2d",inputs,matpar,analysis_type);
    45464534
     
    45554543
    45564544                /*Build alpha_complement_list: */
    4557                 if (drag_type==2) friction->GetAlphaComplement(&alpha_complement, gauss,VxEnum,VyEnum,VzEnum);
    4558                 else alpha_complement=0;
     4545                friction->GetAlphaComplement(&alpha_complement, gauss,VxEnum,VyEnum,VzEnum);
    45594546
    45604547                dragcoefficient_input->GetParameterValue(&drag, gauss);
     
    45874574
    45884575        int        i,j,ig;
    4589         int        drag_type,analysis_type;
     4576        int        analysis_type;
    45904577        int        doflist1[NUMVERTICES];
    45914578        double     bed,thickness,Neff;
     
    46104597        for(i=0;i<NUMVERTICES2D;i++) for(j=0;j<2;j++) xyz_list_tria[i][j]=xyz_list[i][j];
    46114598        GetDofList1(&doflist1[0]);
    4612         inputs->GetParameterValue(&drag_type,DragTypeEnum);
    46134599        Input* drag_input    =inputs->GetInput(DragCoefficientEnum); _assert_(drag_input);
    46144600        Input* vx_input      =inputs->GetInput(VxEnum);              _assert_(vx_input);
     
    46204606
    46214607        /*Build frictoin element, needed later: */
    4622         inputs->GetParameterValue(&drag_type,DragTypeEnum);
    46234608        friction=new Friction("3d",inputs,matpar,analysis_type);
    46244609
     
    46304615
    46314616                /*Recover alpha_complement and drag: */
    4632                 if (drag_type==2) friction->GetAlphaComplement(&alpha_complement, gauss,VxEnum,VyEnum,VzEnum);
    4633                 else alpha_complement=0;
     4617                friction->GetAlphaComplement(&alpha_complement, gauss,VxEnum,VyEnum,VzEnum);
    46344618                drag_input->GetParameterValue(&drag,gauss);
    46354619
     
    66166600                                name==TemperatureEnum ||
    66176601                                name==DragCoefficientEnum ||
    6618                                 name==DragTypeEnum ||
    66196602                                name==GradientEnum ||
    66206603                                name==OldGradientEnum  ||
  • issm/trunk/src/c/objects/Elements/Tria.cpp

    r9405 r9451  
    748748        /*Intermediaries*/
    749749        int        i,j,ig;
    750         int        analysis_type,drag_type;
     750        int        analysis_type;
    751751        double     MAXSLOPE  = .06; // 6 %
    752752        double     MOUNTAINKEXPONENT = 10;
     
    771771        Input* vy_input=inputs->GetInput(VyEnum);           _assert_(vy_input);
    772772        Input* vz_input=inputs->GetInput(VzEnum);           _assert_(vz_input);
    773         inputs->GetParameterValue(&drag_type,DragTypeEnum);
    774773        parameters->FindParam(&analysis_type,AnalysisTypeEnum);
    775774
    776775        /*build friction object, used later on: */
    777         if (drag_type!=2) _error_(" non-viscous friction not supported yet!");
    778776        friction=new Friction("2d",inputs,matpar,analysis_type);
    779777
     
    13801378
    13811379        /*Intermediaries */
    1382         int            i,j,ig,drag_type;
    1383         double         plastic_stress,driving_stress_baseline,thickness;
     1380        int            i,j,ig;
     1381        double         driving_stress_baseline,thickness;
    13841382        double         Jdet;
    13851383        double         xyz_list[NUMVERTICES][3];
     
    13941392        /*Retrieve all inputs and parameters*/
    13951393        GetVerticesCoordinates(&xyz_list[0][0], nodes, NUMVERTICES);
    1396         inputs->GetParameterValue(&drag_type,DragTypeEnum);
    13971394        Input* thickness_input=inputs->GetInput(ThicknessEnum); _assert_(thickness_input);
    13981395        Input* surface_input=inputs->GetInput(SurfaceEnum);     _assert_(surface_input);
     
    14101407                thickness_input->GetParameterValue(&thickness,gauss);
    14111408                surface_input->GetParameterDerivativeValue(&slope[0],&xyz_list[0][0],gauss);
    1412                
    1413                 /*In case we have plastic basal drag, compute plastic stress at gaussian point from k1, k2 and k3 fields in the
    1414                  * element itself: */
    1415                 if(drag_type==1) drag_input->GetParameterValue(&plastic_stress,gauss);
    1416 
    14171409                driving_stress_baseline=matpar->GetRhoIce()*matpar->GetG()*thickness;
    14181410
    14191411                /*Build pe_g_gaussian vector: */
    1420                 if(drag_type==1){
    1421                         for (i=0;i<NUMVERTICES;i++){
    1422                                 for (j=0;j<NDOF2;j++){
    1423                                         pe->values[i*NDOF2+j]+=(-driving_stress_baseline*slope[j]-plastic_stress)*Jdet*gauss->weight*basis[i];
    1424                                 }
    1425                         }
    1426                 }
    1427                 else {
    1428                         for (i=0;i<NUMVERTICES;i++){
    1429                                 for (j=0;j<NDOF2;j++){
    1430                                         pe->values[i*NDOF2+j]+=-driving_stress_baseline*slope[j]*Jdet*gauss->weight*basis[i];
    1431                                 }
     1412                for (i=0;i<NUMVERTICES;i++){
     1413                        for (j=0;j<NDOF2;j++){
     1414                                pe->values[i*NDOF2+j]+=-driving_stress_baseline*slope[j]*Jdet*gauss->weight*basis[i];
    14321415                        }
    14331416                }
     
    28472830
    28482831        int        i,ig;
    2849         int        drag_type,analysis_type;
     2832        int        analysis_type;
    28502833        int        doflist1[NUMVERTICES];
    28512834        double     vx,vy,lambda,mu,alpha_complement,Jdet;
     
    28682851
    28692852        /*Build frictoin element, needed later: */
    2870         inputs->GetParameterValue(&drag_type,DragTypeEnum);
    28712853        friction=new Friction("2d",inputs,matpar,analysis_type);
    28722854
     
    28882870
    28892871                /*Build alpha_complement_list: */
    2890                 if (drag_type==2) friction->GetAlphaComplement(&alpha_complement, gauss,VxEnum,VyEnum,VzEnum);
    2891                 else alpha_complement=0;
     2872                friction->GetAlphaComplement(&alpha_complement, gauss,VxEnum,VyEnum,VzEnum);
    28922873       
    28932874                dragcoefficient_input->GetParameterValue(&drag, gauss);
     
    39983979                                name==DragCoefficientEnum ||
    39993980                                name==GradientEnum ||
    4000                                 name==DragTypeEnum ||
    40013981                                name==OldGradientEnum
    40023982                ){
  • issm/trunk/src/m/classes/@modellist/loadmultipleresultsfromcluster.m

    r2952 r9451  
    2828        md_list.models{i}=loadresultsfromdisk(md_list.models{i},[name '-' num2str(i) 'vs' num2str(nummodels) '.outbin']);
    2929
    30         %post solve phase
    31         md_list.models{i}=postsolveparallel(md_list.models{i});
    3230        delete([name '-' num2str(i) 'vs' num2str(nummodels) '.outbin']);
    3331end
  • issm/trunk/src/m/classes/model.m

    r9431 r9451  
    2828                 y                   = {NaN,true,'DoubleMat',1};
    2929                 z                   = {NaN,true,'DoubleMat',1};
    30                  bed_slopex          = {NaN,false};
    31                  bed_slopey          = {NaN,false};
    32                  surface_slopex      = {NaN,false};
    33                  surface_slopey      = {NaN,false};
    3430                 nodeconnectivity    = {NaN,false};
    3531                 elementconnectivity = {NaN,true,'DoubleMat',3};
     
    4743                 x2d                = {NaN,false};
    4844                 y2d                = {NaN,false};
    49                  z2d                = {NaN,false};
    5045
    5146                 %latlon of the coorinates
     
    7974                 penalties            = {NaN,true,'DoubleMat',3};
    8075                 penalty_offset       = {0,true,'Double'};
    81                  penalty_melting      = {0,true,'Double'};
    8276                 penalty_lock         = {0,true,'Integer'};
    8377                 segments             = {NaN,false};
     
    9690                 %Extrusion
    9791                 numlayers         = {0,true,'Integer'};
    98                  extrusionexponent = {0,false};
    9992                 elementonbed      = {NaN,true,'BooleanMat',2};
    10093                 elementonsurface  = {NaN,true,'BooleanMat',2};
     
    125118                 g                = {0,true,'Double'};
    126119                 yts              = {0,true,'Double'};
    127                  drag_type        = {0,true,'Integer'};
    128120                 drag_coefficient = {NaN,true,'DoubleMat',1};
    129121                 drag_p           = {NaN,true,'DoubleMat',2};
     
    174166                 max_nonlinear_iterations = {0,true,'Integer'};
    175167                 max_steadystate_iterations = {0,true,'Integer'};
    176                  sparsity                 = {0,true,'Double'};
    177168                 connectivity             = {0,true,'Integer'};
    178169                 lowmem                   = {0,true,'Boolean'};
     
    184175                 time_adapt             = {0,true,'Boolean'};
    185176                 cfl_coefficient        = {0,true,'Double'};
    186                  adaptative_cfl         = {0,false};
    187177                 artificial_diffusivity = {0,true,'Integer'};
    188178                 prognostic_DG          = {0,true,'Integer'};
     
    230220                 basal_melting_rate                  = {NaN,true,'DoubleMat',1};
    231221                 basal_melting_rate_correction       = {NaN,true,'DoubleMat',1};
    232                  basal_melting_rate_correction_apply = {0,true,'Integer'};
    233222                 pressure                            = {NaN,true,'DoubleMat',1};
    234223                 %Hydrology
     
    282271                 qmu_mass_flux_segments          = {{},true,'MatArray'};
    283272                 qmu_relax                       = {0,false};
    284                  qmu_save_femmodel               = {0,true,'Integer'};
    285273
    286274                 %flaim
     
    536524                         %basal melting rate correction:
    537525                         md.groundingline_melting_rate=0;
    538                          md.basal_melting_rate_correction_apply=0; %do not apply
    539526
    540527                         %ice thermal conductivity lamda (W/m/K)
     
    563550                         %converstion from year to seconds
    564551                         md.yts=365*24*3600;
    565 
    566                          %drag type (2=elastic)
    567                          md.drag_type=2;
    568552
    569553                         %Solver parameters
     
    583567                         %maximum of steady state iterations
    584568                         md.max_steadystate_iterations=100;
    585 
    586                          %sparsity
    587                          md.sparsity=0.001;
    588569
    589570                         %the connectivity is the avergaded number of nodes linked to a
     
    616597                         %kappa=max(stiffness matrix)*10^penalty_offset
    617598                         md.penalty_offset=3;
    618 
    619                          %penalty_melting is the penalty used to keep T<Tpmp
    620                          %kappa=penalty_melting
    621                          md.penalty_melting=10^7;
    622599
    623600                         %in some solutions, it might be needed to stop a run when only
  • issm/trunk/src/m/model/bamg.m

    r8298 r9451  
    335335md.elementonsurface=ones(md.numberofelements,1);
    336336md.nodeonboundary=zeros(md.numberofnodes,1); md.nodeonboundary(md.segments(:,1:2))=1;
    337 md.counter=1;
    338337md.elementconnectivity=md.bamg.mesh.ElementConnectivity;
    339338md.elementconnectivity(find(isnan(md.elementconnectivity)))=0;
  • issm/trunk/src/m/model/bedslope.m

    r8298 r9451  
    1010        numberofnodes=md.numberofnodes;
    1111        index=md.elements;
    12         x=md.x; y=md.y; z=md.z;
     12        x=md.x; y=md.y;
    1313else
    1414        numberofelements=md.numberofelements2d;
    1515        numberofnodes=md.numberofnodes2d;
    1616        index=md.elements2d;
    17         x=md.x2d; y=md.y2d; z=md.z2d;
     17        x=md.x2d; y=md.y2d;
    1818end
    1919
  • issm/trunk/src/m/model/collapse.m

    r9423 r9451  
    3737if ~isnan(md.vz),md.vz=DepthAverage(md,md.vz);end;
    3838if ~isnan(md.vel),md.vel=DepthAverage(md,md.vel);end;
    39 if ~isnan(md.surface_slopex),md.surface_slopex=project2d(md,md.surface_slopex,md.numlayers);end;
    40 if ~isnan(md.surface_slopey),md.surface_slopey=project2d(md,md.surface_slopey,md.numlayers);end;
    41 if ~isnan(md.bed_slopex),md.bed_slopex=project2d(md,md.bed_slopex,1);end;
    42 if ~isnan(md.bed_slopey),md.bed_slopey=project2d(md,md.bed_slopey,1);end;
    4339
    4440%bedinfo and surface info
     
    10096md.x=md.x2d;
    10197md.y=md.y2d;
    102 md.z=md.z2d;
     98md.z=zeros(size(md.x2d));
    10399md.numberofnodes=md.numberofnodes2d;
    104100md.numberofelements=md.numberofelements2d;
     
    112108md.x2d=NaN;
    113109md.y2d=NaN;
    114 md.z2d=NaN;
    115110md.elements2d=NaN;
    116111md.elements_type2d=md.elements_type;
  • issm/trunk/src/m/model/display/displaydiagnostic.m

    r8823 r9451  
    3030disp(sprintf('\n      %s','Memory management:'));
    3131fielddisplay(md,'lowmem','Set to 1 if you are running low on cluster memory');
    32 fielddisplay(md,'sparsity','matrix sparsity. Set to .001 for < 1M dof, .0001 for 5M dof, and .00001 for > 10M dof');
    3332fielddisplay(md,'connectivity','element connectivity');
    3433
  • issm/trunk/src/m/model/display/displaymesh.m

    r8298 r9451  
    2020        fielddisplay(md,'x2d','nodes x coordinate');
    2121        fielddisplay(md,'y2d','nodes y coordinate');
    22         fielddisplay(md,'z2d','nodes z coordinate');
    2322
    2423        disp(sprintf('\n      Elements and nodes of the extruded 3d mesh:'));
     
    3837fielddisplay(md,'dim','mesh dimension (2d or 3d)');
    3938fielddisplay(md,'numlayers','number of extrusion layers');
    40 fielddisplay(md,'extrusionexponent','exponent for extrusion');
    4139fielddisplay(md,'bamg','Geometry and 2d mesh properties (if generated by Bamg)');
    4240fielddisplay(md,'penalties','penalties list');
  • issm/trunk/src/m/model/display/displayparameters.m

    r8298 r9451  
    2626
    2727disp(sprintf('\n      Friction parameters (Sigma= drag^2 * Neff ^r * u ^s, with Neff=rho_ice*g*thickness+rho_ice*g*bed, r=q/p and s=1/p)'));
    28 fielddisplay(md,'drag_type','0: none, 1:plastic, 2:viscous');
    2928fielddisplay(md,'drag_coefficient','friction coefficient [IS]');
    3029fielddisplay(md,'drag_p','p exponent');
  • issm/trunk/src/m/model/divergence.m

    r8298 r9451  
    1414        numberofnodes=md.numberofnodes2d;
    1515        index=md.elements2d;
    16         x=md.x2d; y=md.y2d; z=md.z2d;
     16        x=md.x2d; y=md.y2d;
    1717end
    1818
  • issm/trunk/src/m/model/extrude.m

    r9432 r9451  
    2525        help extrude;
    2626        error('extrude error message');
    27 end
    28 
    29 if md.counter<3,
    30         help extrude;
    31         error('only fully parameterized 2d models can be extruded');
    32 end
    33 
    34 if md.counter>=4,
    35         error('This model has already been extruded!','s');
    3627end
    3728
     
    114105md.x2d=md.x;
    115106md.y2d=md.y;
    116 md.z2d=md.z;
    117107md.elements2d=md.elements;
    118108md.elements_type2d=md.elements_type;
     
    158148if ~isnan(md.temperature),md.temperature=project3d(md,'vector',md.temperature,'type','node');end;
    159149if ~isnan(md.waterfraction),md.waterfraction=project3d(md,'vector',md.waterfraction,'type','node');end;
    160 if ~isnan(md.surface_slopex),md.surface_slopex=project3d(md,'vector',md.surface_slopex,'type','node');end;
    161 if ~isnan(md.surface_slopey),md.surface_slopey=project3d(md,'vector',md.surface_slopey,'type','node');end;
    162 if ~isnan(md.bed_slopex),md.bed_slopex=project3d(md,'vector',md.bed_slopex,'type','node');end;
    163 if ~isnan(md.bed_slopey),md.bed_slopey=project3d(md,'vector',md.bed_slopey,'type','node');end;
    164150
    165151%bedinfo and surface info
     
    246232        md.connectivity=100;
    247233end
    248 
    249 %augment counter  keeping track of what has been done to this model
    250 md.counter=4;
  • issm/trunk/src/m/model/geography.m

    r9423 r9451  
    1818        help geography
    1919        error('geography error message');
    20 end
    21 
    22 if md.counter>=2,
    23         choice=input('This model already has a geometry. Are you sure you want to go ahead? (y/n)','s');
    24         if ~strcmp(choice,'y'), error('no geometry done ... exiting'); end
    25 else
    26         if (md.counter~=1), error('geography error message: you need to run mesh.m first on this model'); end
    2720end
    2821
     
    4942
    5043%Return:
    51 md.counter=2;
    52 
    5344md.elementoniceshelf=elementoniceshelf;
    5445md.nodeoniceshelf=nodeoniceshelf;
  • issm/trunk/src/m/model/geography2.m

    r8298 r9451  
    148148md.elementonicesheet=elementonicesheet;
    149149
    150 md.counter=2;
    151150md.segmentmarkers(:)=1;
  • issm/trunk/src/m/model/ismodelselfconsistent.m

    r9432 r9451  
    4242end
    4343%}}}
    44 %COUNTER {{{1
    45 if md.counter<3,
    46         message(['model ' md.name ' is not correctly configured. You forgot one step in the following sequence (mesh, geography, parameterize,setelementstype)!']);
    47 end
    48 %}}}
    4944%NAME{{{1
    5045if isempty(md.name),
     
    8782%}}}
    8883%NO NAN {{{1
    89 fields={'numberofelements','numberofnodes','x','y','z','drag_coefficient','drag_type','drag_p','drag_q',...
    90         'rho_ice','rho_water','rheology_B','elementoniceshelf','surface','thickness','bed','g','lowmem','sparsity','nsteps','maxiter',...
     84fields={'numberofelements','numberofnodes','x','y','z','drag_coefficient','drag_p','drag_q',...
     85        'rho_ice','rho_water','rheology_B','elementoniceshelf','surface','thickness','bed','g','lowmem','nsteps','maxiter',...
    9186        'tolx','eps_res','max_nonlinear_iterations','rheology_n','nodeonbed','nodeonsurface','elementonbed','elementonsurface','elementconnectivity'};
    9287checknan(md,fields);
    9388%}}}}
    9489%FIELDS >= 0 {{{1
    95 fields={'numberofelements','numberofnodes','elements','drag_coefficient','drag_type','drag_p','drag_q',...
     90fields={'numberofelements','numberofnodes','elements','drag_coefficient','drag_p','drag_q',...
    9691        'rho_ice','rho_water','rheology_B','elementoniceshelf','thickness','g','eps_res','max_nonlinear_iterations','eps_rel','eps_abs','nsteps','maxiter','tolx',...
    97         'sparsity','lowmem','rheology_n','nodeonbed','nodeonsurface','elementonbed','elementonsurface'};
     92        'lowmem','rheology_n','nodeonbed','nodeonsurface','elementonbed','elementonsurface'};
    9893checkgreater(md,fields,0);
    9994%}}}
    10095%FIELDS > 0 {{{1
    101 fields={'numberofelements','numberofnodes','elements','drag_type','drag_p',...
    102         'rho_ice','rho_water','rheology_B','thickness','g','max_nonlinear_iterations','eps_res','eps_rel','eps_abs','maxiter','tolx',...
    103         'sparsity'};
     96fields={'numberofelements','numberofnodes','elements','drag_p',...
     97        'rho_ice','rho_water','rheology_B','thickness','g','max_nonlinear_iterations','eps_res','eps_rel','eps_abs','maxiter','tolx'};
    10498checkgreaterstrict(md,fields,0);
    10599%}}}
  • issm/trunk/src/m/model/isresultconsistent.m

    r8430 r9451  
    147147                %check melting (<=0 via penalties)
    148148                if any(abs(md.results.ThermalAnalysis(iter).melting(md.numberofnodes2d+1:end))>tolerance)
    149                         disp(['''thermal'' result not consistent: increase penalty_melting (negative melting)']);
     149                        disp(['''thermal'' result not consistent: increase penalty_offset (negative melting)']);
    150150                        bool=0; return;
    151151                end
     
    197197                if (md.dim==3),
    198198                        if any(abs(md.results.TransientAnalysis(iter).melting(md.numberofnodes2d+1:end))>tolerance)
    199                                 disp(['''thermal'' result not consistent: increase penalty_melting (negative melting)']);
     199                                disp(['''thermal'' result not consistent: increase penalty_offset (negative melting)']);
    200200                                bool=0; return;
    201201                        end
  • issm/trunk/src/m/model/loadmultipleresultsfromcluster.m

    r7629 r9451  
    2828        md_list{i}=loadresultsfromdisk(md_list{i},[md_list{i}.name '.outbin']);
    2929
    30         %post solve phase
    31         md_list{i}=postsolveparallel(md_list{i});
    3230        delete([name '.outbin']);
    3331end
  • issm/trunk/src/m/model/loadresultsfromcluster.m

    r8577 r9451  
    5858        end
    5959end
    60 
    61 %post solve phase
    62 md=postsolveparallel(md);
  • issm/trunk/src/m/model/mesh/mesh.m

    r9423 r9451  
    8484%type of model
    8585md.dim=2;
    86        
    87 %augment counter  keeping track of what has been done to this model
    88 md.counter=1;
  • issm/trunk/src/m/model/mesh/meshconvert.m

    r8298 r9451  
    4646md.elementonsurface=ones(md.numberofelements,1);
    4747md.nodeonboundary=zeros(md.numberofnodes,1); md.nodeonboundary(md.segments(:,1:2))=1;
    48 md.counter=1;
  • issm/trunk/src/m/model/mesh/meshexprefine.m

    r5024 r9451  
    2323        meshexprefineusage();
    2424        error('meshexprefine error message');
    25 end
    26 
    27 if (md.counter<1)
    28         error('meshexprefine error message: you need to run mesh.m first on this model');
    2925end
    3026
  • issm/trunk/src/m/model/mesh/meshnodensity.m

    r9423 r9451  
    7070%type of model
    7171md.dim=2;
    72        
    73 %augment counter  keeping track of what has been done to this model
    74 md.counter=1;
  • issm/trunk/src/m/model/mesh/meshrefine.m

    r8298 r9451  
    3535%type of model
    3636md.dim=2;
    37        
    38 %augment counter  keeping track of what has been done to this model
    39 md.counter=1;
    4037end
    4138
  • issm/trunk/src/m/model/mesh/reorder.m

    r8298 r9451  
    66
    77%some checks
    8 if md.counter<1,
    9         error('reorder error message: no existing mesh, exiting...')
    10 end
    118if md.dim==3,
    129        error('reorder error message: 3d models not supported yet, exiting...')
  • issm/trunk/src/m/model/mesh/rifts/meshaddrifts.m

    r8298 r9451  
    9292%type of model
    9393md.dim=2;
    94        
    95 %augment counter  keeping track of what has been done to this model
    96 md.counter=1;
  • issm/trunk/src/m/model/modelextract.m

    r9436 r9451  
    142142                md2.x2d=md1.x(pos_node_2d);
    143143                md2.y2d=md1.y(pos_node_2d);
    144                 md2.z2d=md1.z(pos_node_2d);
    145144        end
    146145
  • issm/trunk/src/m/model/parameterization/parameterize.m

    r9423 r9451  
    1313
    1414%some checks
    15 if md.counter>=4,
    16         %We need to take this out, as it gets too constraining.
    17         choice=input('This model already has parameters and has been extruded. Are you sure you want to go ahead? (y/n)','s');
    18         if ~strcmp(choice,'y')
    19                 error('no parameters done ... exiting');
    20         end
    21 elseif md.counter==3
    22         disp('This model already has parameters, overwriting...')
    23 else
    24         if (md.counter<2)
    25                 error('parameterize error message: you need to run geography.m first on this model');
    26         else
    27                 md.counter=3;
    28         end
    29 end
    3015if ~exist(parametername),
    3116        error(['parameterize error message: file ' parametername ' not found !']);
  • issm/trunk/src/m/model/plot/processmesh.m

    r8728 r9451  
    3737
    3838
    39         z2d=md.z2d;
    4039        elements2d=md.elements2d;
    4140        elements=md.elements;
     
    6362                x=x2d;
    6463                y=y2d;
    65                 z=z2d;
     64                z=zeros(size(x2d));
    6665                elements=elements2d;
    6766                elements_type=elements_type2d;
  • issm/trunk/src/m/model/setelementstype.m

    r8823 r9451  
    2222if ((nargin<2) | (nargout~=1)),
    2323        error('setelementstype error message');
    24 end
    25 
    26 if md.counter<3,
    27         error('only fully parameterized 2d models can be setelementstyped');
    2824end
    2925
  • issm/trunk/src/m/model/slope.m

    r8298 r9451  
    1010        numberofnodes=md.numberofnodes;
    1111        index=md.elements;
    12         x=md.x; y=md.y; z=md.z;
     12        x=md.x; y=md.y;
    1313else
    1414        numberofelements=md.numberofelements2d;
    1515        numberofnodes=md.numberofnodes2d;
    1616        index=md.elements2d;
    17         x=md.x2d; y=md.y2d; z=md.z2d;
     17        x=md.x2d; y=md.y2d;
    1818end
    1919
  • issm/trunk/src/m/qmu/qmumarshall.m

    r6733 r9451  
    6464WriteData(fid,md.part,'Mat','part');
    6565
    66 WriteData(fid,md.qmu_save_femmodel,'Integer','qmu_save_femmodel');
    67 
    6866%close file
    6967st=fclose(fid);
  • issm/trunk/src/m/solutions/SpawnCore.m

    r8944 r9451  
    1010solution_type=femmodel.parameters.SolutionType;
    1111control_analysis=femmodel.parameters.ControlAnalysis;
    12 qmu_save_femmodel=femmodel.parameters.QmuSaveFemmodel;
    1312
    1413issmprintf(VerboseQmu(),'%s%i',['   qmu iteration:'],counter);
     
    2423%now process the results to get response function values
    2524responses=DakotaResponses(femmodel.elements,femmodel.nodes,femmodel.vertices,femmodel.loads,femmodel.materials,femmodel.parameters,responsedescriptors);
    26 
    27 if qmu_save_femmodel
    28     issmprintf(VerboseQmu(),'%s%i%s',['   writing femmodel to femmodel_spawncorem_'],counter,['.mat']);
    29     save(sprintf('femmodel_spawncorem_%i',counter),'femmodel');
    30 end
    31 
  • issm/trunk/src/m/utils/Mesh/argusmesh.m

    r9423 r9451  
    8787md.elementonbed=ones(md.numberofelements,1);
    8888md.elementonsurface=ones(md.numberofelements,1);
    89 md.counter=1;
    9089md.dim=2;
    9190md=addnote(md,notes);
  • issm/trunk/src/m/utils/Mesh/squaremesh.m

    r9423 r9451  
    7878%plug other field
    7979md.dim=2;
    80 md.counter=1;
Note: See TracChangeset for help on using the changeset viewer.